library("tidyverse")
library("tibble")
library("msigdbr")
library("ggplot2")
library("TCGAbiolinks")
library("RNAseqQC")
library("DESeq2")
library("ensembldb")
library("purrr")
library("magrittr")
library("vsn")
library("matrixStats")
library("dplyr")
library("grex")
library("survminer")
library("survival")
Create a function for downloading TCGA gene expression data.
For more detailed documentation, refer to
2. Differential Gene Expression Analysis - TCGA.Rmd
.
query_and_filter_samples <- function(project) {
query_tumor <- GDCquery(
project = project,
data.category = "Transcriptome Profiling",
data.type = "Gene Expression Quantification",
experimental.strategy = "RNA-Seq",
workflow.type = "STAR - Counts",
access = "open",
sample.type = "Primary Tumor"
)
tumor <- getResults(query_tumor)
query_normal <- GDCquery(
project = project,
data.category = "Transcriptome Profiling",
data.type = "Gene Expression Quantification",
experimental.strategy = "RNA-Seq",
workflow.type = "STAR - Counts",
access = "open",
sample.type = "Solid Tissue Normal"
)
normal <- getResults(query_normal)
submitter_ids <- inner_join(tumor, normal, by = "cases.submitter_id") %>%
dplyr::select(cases.submitter_id)
tumor <- tumor %>%
dplyr::filter(cases.submitter_id %in% submitter_ids$cases.submitter_id)
normal <- normal %>%
dplyr::filter(cases.submitter_id %in% submitter_ids$cases.submitter_id)
samples <- rbind(tumor, normal)
unique(samples$sample_type)
query_project <- GDCquery(
project = project,
data.category = "Transcriptome Profiling",
data.type = "Gene Expression Quantification",
experimental.strategy = "RNA-Seq",
workflow.type = "STAR - Counts",
access = "open",
sample.type = c("Solid Tissue Normal", "Primary Tumor"),
barcode = as.list(samples$sample.submitter_id)
)
# If this is your first time running this notebook (i.e., you have not yet downloaded the results of the query in the previous block),
# uncomment the line below
# GDCdownload(query_project)
return(list(samples = samples, query_project = query_project))
}
Download the TCGA gene expression data for colorectal cancer (TCGA-COAD).
projects <- c("TCGA-COAD")
with_results_projects <- c()
samples <- list()
project_data <- list()
for (project in projects) {
result <- tryCatch(
{
result <- query_and_filter_samples(project)
samples[[project]] <- result$samples
project_data[[project]] <- result$query_project
with_results_projects <- c(with_results_projects, project)
},
error = function(e) {
}
)
}
Running the code block above should generate and populate a directory
named GDCdata
.
Construct the RNA-seq count matrix for each cancer type.
tcga_data <- list()
tcga_matrix <- list()
projects <- with_results_projects
for (project in projects) {
tcga_data[[project]] <- GDCprepare(project_data[[project]], summarizedExperiment = TRUE)
}
for (project in projects) {
count_matrix <- assay(tcga_data[[project]], "unstranded")
# Remove duplicate entries
count_matrix_df <- data.frame(count_matrix)
count_matrix_df <- count_matrix_df[!duplicated(count_matrix_df), ]
count_matrix <- data.matrix(count_matrix_df)
rownames(count_matrix) <- cleanid(rownames(count_matrix))
count_matrix <- count_matrix[!(duplicated(rownames(count_matrix)) | duplicated(rownames(count_matrix), fromLast = TRUE)), ]
tcga_matrix[[project]] <- count_matrix
}
Format the samples
table so that it can be fed as input
to DESeq2.
for (project in projects) {
rownames(samples[[project]]) <- samples[[project]]$cases
samples[[project]] <- samples[[project]] %>%
dplyr::select(case = "cases.submitter_id", type = "sample_type")
samples[[project]]$type <- str_replace(samples[[project]]$type, "Solid Tissue Normal", "normal")
samples[[project]]$type <- str_replace(samples[[project]]$type, "Primary Tumor", "tumor")
}
DESeq2 requires the row names of samples
should be
identical to the column names of count_matrix
.
for (project in projects) {
colnames(tcga_matrix[[project]]) <- gsub(x = colnames(tcga_matrix[[project]]), pattern = "\\.", replacement = "-")
tcga_matrix[[project]] <- tcga_matrix[[project]][, rownames(samples[[project]])]
# Sanity check
print(all(colnames(tcga_matrix[[project]]) == rownames(samples[[project]])))
}
For more detailed documentation on obtaining the gene set, refer to
7. Differential Gene Expression Analysis - TCGA - Pan-cancer - Unique Genes.Rmd
.
RCDdb <- "temp/unique_genes/necroptosis_ferroptosis_pyroptosis/"
Write utility functions for filtering the gene sets, performing differential gene expression analysis, plotting the results, and performing variance-stabilizing transformation.
filter_gene_set_and_perform_dgea <- function(genes) {
tcga_rcd <- list()
for (project in projects) {
rownames(genes) <- genes$gene_id
tcga_rcd[[project]] <- tcga_matrix[[project]][rownames(tcga_matrix[[project]]) %in% genes$gene_id, ]
tcga_rcd[[project]] <- tcga_rcd[[project]][, rownames(samples[[project]])]
}
dds_rcd <- list()
res_rcd <- list()
for (project in projects) {
print(project)
print("=============")
dds <- DESeqDataSetFromMatrix(
countData = tcga_rcd[[project]],
colData = samples[[project]],
design = ~type
)
dds <- filter_genes(dds, min_count = 10)
dds$type <- relevel(dds$type, ref = "normal")
dds_rcd[[project]] <- DESeq(dds)
res_rcd[[project]] <- results(dds_rcd[[project]])
}
deseq.bbl.data <- list()
for (project in projects) {
deseq.results <- res_rcd[[project]]
deseq.bbl.data[[project]] <- data.frame(
row.names = rownames(deseq.results),
baseMean = deseq.results$baseMean,
log2FoldChange = deseq.results$log2FoldChange,
lfcSE = deseq.results$lfcSE,
stat = deseq.results$stat,
pvalue = deseq.results$pvalue,
padj = deseq.results$padj,
cancer_type = project,
gene_symbol = genes[rownames(deseq.results), "gene"]
)
}
deseq.bbl.data.combined <- bind_rows(deseq.bbl.data)
deseq.bbl.data.combined <- dplyr::filter(deseq.bbl.data.combined, abs(log2FoldChange) >= 1.5 & padj < 0.05)
return(deseq.bbl.data.combined)
}
plot_dgea <- function(deseq.bbl.data.combined) {
sizes <- c("<10^-15" = 4, "10^-10" = 3, "10^-5" = 2, "0.05" = 1)
deseq.bbl.data.combined <- deseq.bbl.data.combined %>%
mutate(fdr_category = cut(padj,
breaks = c(-Inf, 1e-15, 1e-10, 1e-5, 0.05),
labels = c("<10^-15", "10^-10", "10^-5", "0.05"),
right = FALSE
))
top_genes <- deseq.bbl.data.combined %>%
group_by(cancer_type) %>%
mutate(rank = rank(-abs(log2FoldChange))) %>%
dplyr::filter(rank <= 10) %>%
ungroup()
ggplot(top_genes, aes(y = cancer_type, x = gene_symbol, size = fdr_category, fill = log2FoldChange)) +
geom_point(alpha = 0.5, shape = 21, color = "black") +
scale_size_manual(values = sizes) +
scale_fill_gradient2(low = "blue", mid = "white", high = "red", limits = c(min(deseq.bbl.data.combined$log2FoldChange), max(deseq.bbl.data.combined$log2FoldChange))) +
theme_minimal() +
theme(
axis.text.x = element_text(size = 9, angle = 90, hjust = 1)
) +
theme(legend.position = "bottom") +
theme(legend.position = "bottom") +
labs(size = "Adjusted p-value", fill = "log2 FC", y = "Cancer type", x = "Gene")
}
perform_vsd <- function(genes) {
tcga_rcd <- list()
for (project in projects) {
rownames(genes) <- genes$gene_id
tcga_rcd[[project]] <- tcga_matrix[[project]][rownames(tcga_matrix[[project]]) %in% genes$gene_id, ]
tcga_rcd[[project]] <- tcga_rcd[[project]][, rownames(samples[[project]])]
}
vsd_rcd <- list()
for (project in projects) {
print(project)
print("=============")
dds <- DESeqDataSetFromMatrix(
countData = tcga_rcd[[project]],
colData = samples[[project]],
design = ~type
)
dds <- filter_genes(dds, min_count = 10)
# Perform variance stabilization
dds <- estimateSizeFactors(dds)
nsub <- sum(rowMeans(counts(dds, normalized = TRUE)) > 10)
vsd <- vst(dds, nsub = nsub)
vsd_rcd[[project]] <- assay(vsd)
}
return(vsd_rcd)
}
Fetch the gene set of interest.
genes <- read.csv(paste0(RCDdb, "Ferroptosis.csv"))
print(genes)
genes$gene_id <- cleanid(genes$gene_id)
genes <- distinct(genes, gene_id, .keep_all = TRUE)
genes <- subset(genes, gene_id != "")
genes
Filter the genes to include only those in the gene set of interest, and then perform differential gene expression analysis.
deseq.bbl.data.combined <- filter_gene_set_and_perform_dgea(genes)
[1] "TCGA-COAD"
[1] "============="
Warning: some variables in design formula are characters, converting to factorsestimating size factors
estimating dispersions
gene-wise dispersion estimates
mean-dispersion relationship
final dispersion estimates
fitting model and testing
-- replacing outliers and refitting for 21 genes
-- DESeq argument 'minReplicatesForReplace' = 7
-- original counts are preserved in counts(dds)
estimating dispersions
fitting model and testing
deseq.bbl.data.combined
Plot the results.
plot_dgea(deseq.bbl.data.combined)
Perform variance-stabilizing transformation for further downstream analysis (i.e., for survival analysis).
vsd <- perform_vsd(genes)
[1] "TCGA-COAD"
[1] "============="
Download clinical data from TCGA, and perform some preprocessing: -
The deceased
column should be FALSE
if the
patient is alive and TRUE
otherwise - The
overall_survival
column should reflect the follow-up time
if the patient is alive and the days to death otherwise
download_clinical_data <- function(project) {
clinical_data <- GDCquery_clinic(project)
clinical_data$deceased <- ifelse(clinical_data$vital_status == "Alive", FALSE, TRUE)
clinical_data$overall_survival <- ifelse(clinical_data$vital_status == "Alive",
clinical_data$days_to_last_follow_up,
clinical_data$days_to_death
)
return(clinical_data)
}
tcga_clinical <- list()
for (project in projects) {
tcga_clinical[[project]] <- download_clinical_data(project)
}
Write utility functions for performing survival analysis.
construct_gene_df <- function(gene_of_interest, project) {
gene_df <- vsd[[project]] %>%
as.data.frame() %>%
rownames_to_column(var = "gene_id") %>%
gather(key = "case_id", value = "counts", -gene_id) %>%
left_join(., genes, by = "gene_id") %>%
dplyr::filter(gene == gene_of_interest) %>%
dplyr::filter(case_id %in% rownames(samples[[project]] %>% dplyr::filter(type == "tumor")))
q1 <- quantile(gene_df$counts, probs = 0.25)
q3 <- quantile(gene_df$counts, probs = 0.75)
gene_df$strata <- ifelse(gene_df$counts >= q3, "HIGH", ifelse(gene_df$counts <= q1, "LOW", "MIDDLE"))
gene_df <- gene_df %>% dplyr::filter(strata %in% c("LOW", "HIGH"))
gene_df$case_id <- paste0(sapply(strsplit(as.character(gene_df$case_id), "-"), `[`, 1), '-',
sapply(strsplit(as.character(gene_df$case_id), "-"), `[`, 2), '-',
sapply(strsplit(as.character(gene_df$case_id), "-"), `[`, 3))
gene_df <- merge(gene_df, tcga_clinical[[project]], by.x = "case_id", by.y = "submitter_id")
return(gene_df)
}
compute_surival_fit <- function(gene_df) {
return (survfit(Surv(overall_survival, deceased) ~ strata, data = gene_df))
}
compute_cox <- function(gene_df) {
return (coxph(Surv(overall_survival, deceased) ~ strata, data=gene_df))
}
plot_survival <- function(fit) {
return(ggsurvplot(fit,
data = gene_df,
pval = T,
risk.table = T,
risk.table.height = 0.3
))
}
compute_survival_diff <- function(gene_df) {
return(survdiff(Surv(overall_survival, deceased) ~ strata, data = gene_df))
}
Perform survival analysis by testing for the difference in the Kaplan-Meier curves using the G-rho family of Harrington and Fleming tests: https://rdrr.io/cran/survival/man/survdiff.html
significant_projects <- c()
significant_genes <- c()
ctr <- 1
for (project in projects) {
for (gene in c(genes$gene)) {
cat(project, gene, "\n\n")
error <- tryCatch (
{
gene_df <- construct_gene_df(gene, project)
},
error = function(e) {
cat("\n\n============================\n\n")
e
}
)
if(inherits(error, "error")) next
if (nrow(gene_df) > 0) {
fit <- compute_surival_fit(gene_df)
tryCatch (
{
survival <- compute_survival_diff(gene_df)
cox <- compute_cox(gene_df)
print(ctr)
ctr <- ctr + 1
print(survival)
cat("\n")
print(cox)
print(plot_survival(fit))
if (pchisq(survival$chisq, length(survival$n)-1, lower.tail = FALSE) < 0.05) {
significant_projects <- c(significant_projects, project)
significant_genes <- c(significant_genes, gene)
}
},
error = function(e) {
}
)
}
cat("\n\n============================\n\n")
}
}
TCGA-COAD MIR212
============================
TCGA-COAD NR5A2
[1] 1
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.8 1.16 2.24
strata=LOW 12 5 3.2 1.01 2.24
Chisq= 2.2 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.511 4.532 1.103 1.37 0.171
Likelihood ratio test=2.47 on 1 df, p=0.1161
n= 24, number of events= 6
============================
TCGA-COAD TFAM
[1] 2
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 1.29 1.288 2.3
strata=LOW 12 3 1.71 0.969 2.3
Chisq= 2.3 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.100e+01 1.312e+09 2.372e+04 0.001 0.999
Likelihood ratio test=3.41 on 1 df, p=0.06482
n= 24, number of events= 3
============================
TCGA-COAD CREB5
[1] 3
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.41 0.828 2.1
strata=LOW 12 3 1.59 1.260 2.1
Chisq= 2.1 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.525 4.593 1.157 1.318 0.187
Likelihood ratio test=2.07 on 1 df, p=0.1502
n= 24, number of events= 4
============================
TCGA-COAD NOS2
[1] 4
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.3 0.514 1.87
strata=LOW 12 3 1.7 1.001 1.87
Chisq= 1.9 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.532 4.626 1.205 1.271 0.204
Likelihood ratio test=1.9 on 1 df, p=0.1676
n= 24, number of events= 5
============================
TCGA-COAD HULC
[1] 5
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.95 0.308 0.77
strata=LOW 12 4 3.05 0.299 0.77
Chisq= 0.8 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7909 2.2053 0.9235 0.856 0.392
Likelihood ratio test=0.75 on 1 df, p=0.3853
n= 24, number of events= 6
============================
TCGA-COAD PLXNB2
[1] 6
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 0.722 0.1068 0.168
strata=LOW 12 1 1.278 0.0604 0.168
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.5726 0.5641 1.4168 -0.404 0.686
Likelihood ratio test=0.16 on 1 df, p=0.6881
n= 24, number of events= 2
============================
TCGA-COAD KIF20A
[1] 7
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.78 0.161 0.619
strata=LOW 12 3 2.22 0.273 0.619
Chisq= 0.6 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.8821 2.4160 1.1576 0.762 0.446
Likelihood ratio test=0.66 on 1 df, p=0.4179
n= 24, number of events= 6
============================
TCGA-COAD TIMP1
[1] 8
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 6 2.38 5.51 9.2
strata=LOW 12 0 3.62 3.62 9.2
Chisq= 9.2 on 1 degrees of freedom, p= 0.002
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.173e+01 3.653e-10 1.714e+04 -0.001 0.999
Likelihood ratio test=11.17 on 1 df, p=0.0008311
n= 24, number of events= 6
============================
TCGA-COAD MIR615
============================
TCGA-COAD MIR93
============================
TCGA-COAD ENO3
[1] 9
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.59 0.0458 0.112
strata=LOW 12 3 3.41 0.0484 0.112
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2726 0.7614 0.8170 -0.334 0.739
Likelihood ratio test=0.11 on 1 df, p=0.739
n= 24, number of events= 7
============================
TCGA-COAD MMD
[1] 10
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 5.62 1.22 4.44
strata=LOW 12 5 2.38 2.89 4.44
Chisq= 4.4 on 1 degrees of freedom, p= 0.04
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.6070 4.9877 0.8434 1.905 0.0567
Likelihood ratio test=4.15 on 1 df, p=0.04173
n= 24, number of events= 8
============================
TCGA-COAD NQO1
[1] 11
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.2 0.447 1.24
strata=LOW 12 3 1.8 0.792 1.24
Chisq= 1.2 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.9779 2.6589 0.9134 1.071 0.284
Likelihood ratio test=1.18 on 1 df, p=0.2781
n= 24, number of events= 5
============================
TCGA-COAD MARCHF5
[1] 12
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.52 0.0912 0.184
strata=LOW 12 3 3.48 0.0661 0.184
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3900 0.6771 0.9140 -0.427 0.67
Likelihood ratio test=0.19 on 1 df, p=0.6665
n= 24, number of events= 6
============================
TCGA-COAD JUN
[1] 13
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 4.95 0.000567 0.00152
strata=LOW 12 4 4.05 0.000692 0.00152
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.02881 0.97160 0.73891 -0.039 0.969
Likelihood ratio test=0 on 1 df, p=0.9689
n= 24, number of events= 9
============================
TCGA-COAD ALDH3A2
[1] 14
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 4.39 0.0853 0.193
strata=LOW 12 4 4.61 0.0812 0.193
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3112 0.7326 0.7104 -0.438 0.661
Likelihood ratio test=0.19 on 1 df, p=0.662
n= 24, number of events= 9
============================
TCGA-COAD ALOX5
[1] 15
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 6 3.94 1.07 3.65
strata=LOW 12 0 2.06 2.06 3.65
Chisq= 3.7 on 1 degrees of freedom, p= 0.06
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.099e+01 7.682e-10 1.867e+04 -0.001 0.999
Likelihood ratio test=5.44 on 1 df, p=0.01965
n= 24, number of events= 6
============================
TCGA-COAD PARP9
[1] 16
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.44 0.0573 0.158
strata=LOW 12 3 2.56 0.0772 0.158
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3611 1.4350 0.9132 0.395 0.692
Likelihood ratio test=0.16 on 1 df, p=0.6897
n= 24, number of events= 6
============================
TCGA-COAD GLRX5
[1] 17
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 0.775 0.0653 0.107
strata=LOW 12 1 1.225 0.0413 0.107
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4581 0.6325 1.4147 -0.324 0.746
Likelihood ratio test=0.1 on 1 df, p=0.7471
n= 24, number of events= 2
============================
TCGA-COAD METTL14
[1] 18
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.52 0.92 3.3
strata=LOW 12 3 1.48 1.57 3.3
Chisq= 3.3 on 1 degrees of freedom, p= 0.07
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.139e+01 1.948e+09 2.378e+04 0.001 0.999
Likelihood ratio test=4.43 on 1 df, p=0.03532
n= 24, number of events= 4
============================
TCGA-COAD TOR2A
[1] 19
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.1 0.388 0.67
strata=LOW 12 2 2.9 0.280 0.67
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7322 0.4808 0.9142 -0.801 0.423
Likelihood ratio test=0.66 on 1 df, p=0.4169
n= 24, number of events= 5
============================
TCGA-COAD PARP14
[1] 20
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.62 0.723 2.14
strata=LOW 12 4 2.38 1.096 2.14
Chisq= 2.1 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.512 4.535 1.128 1.34 0.18
Likelihood ratio test=2.27 on 1 df, p=0.1321
n= 24, number of events= 6
============================
TCGA-COAD MIR130B
============================
TCGA-COAD CERS6-AS1
============================
TCGA-COAD NFS1
[1] 21
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.93 0.00267 0.00517
strata=LOW 12 3 3.07 0.00168 0.00517
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.07191 0.93062 1.00074 -0.072 0.943
Likelihood ratio test=0.01 on 1 df, p=0.9427
n= 24, number of events= 5
============================
TCGA-COAD SLC3A2
[1] 22
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 0.529 0.418 0.889
strata=LOW 12 1 1.471 0.151 0.889
Chisq= 0.9 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.109e+01 6.926e-10 4.030e+04 -0.001 1
Likelihood ratio test=1.27 on 1 df, p=0.2594
n= 24, number of events= 2
============================
TCGA-COAD ZFAS1
[1] 23
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.06 0.001102 0.00225
strata=LOW 12 4 3.94 0.000855 0.00225
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.03881 1.03957 0.81753 0.047 0.962
Likelihood ratio test=0 on 1 df, p=0.9621
n= 24, number of events= 7
============================
TCGA-COAD PANX1
[1] 24
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 4.39 0.0341 0.156
strata=LOW 12 2 1.61 0.0928 0.156
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3927 1.4810 1.0012 0.392 0.695
Likelihood ratio test=0.15 on 1 df, p=0.6958
n= 24, number of events= 6
============================
TCGA-COAD HSPB1
[1] 25
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.18 1.041 2.31
strata=LOW 12 2 3.82 0.867 2.31
Chisq= 2.3 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.5343 0.2156 1.1048 -1.389 0.165
Likelihood ratio test=2.54 on 1 df, p=0.1111
n= 24, number of events= 7
============================
TCGA-COAD CREB1
[1] 26
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.79 1.15 3.36
strata=LOW 12 4 2.21 1.45 3.36
Chisq= 3.4 on 1 degrees of freedom, p= 0.07
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.110e+01 1.456e+09 2.051e+04 0.001 0.999
Likelihood ratio test=4.87 on 1 df, p=0.02737
n= 24, number of events= 5
============================
TCGA-COAD EZH2
[1] 27
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.48 0.63 2.38
strata=LOW 12 3 1.52 1.44 2.38
Chisq= 2.4 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.620 5.054 1.163 1.393 0.164
Likelihood ratio test=2.31 on 1 df, p=0.1283
n= 24, number of events= 5
============================
TCGA-COAD SLC40A1
[1] 28
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.79 0.846 2.31
strata=LOW 12 5 3.21 1.000 2.31
Chisq= 2.3 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.2416 3.4612 0.8687 1.429 0.153
Likelihood ratio test=2.21 on 1 df, p=0.1373
n= 24, number of events= 7
============================
TCGA-COAD PAQR3
[1] 29
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.47 0.0646 0.18
strata=LOW 12 3 2.53 0.0888 0.18
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3846 1.4690 0.9131 0.421 0.674
Likelihood ratio test=0.18 on 1 df, p=0.6706
n= 24, number of events= 6
============================
TCGA-COAD MIR545
============================
TCGA-COAD MIR6077
============================
TCGA-COAD MIR424
============================
TCGA-COAD NOX5
[1] 30
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.63 0.0515 0.109
strata=LOW 12 2 2.37 0.0572 0.109
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3019 0.7394 0.9159 -0.33 0.742
Likelihood ratio test=0.11 on 1 df, p=0.7397
n= 24, number of events= 5
============================
TCGA-COAD DHODH
[1] 31
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.12 0.251 0.466
strata=LOW 12 3 3.88 0.202 0.466
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.5244 0.5919 0.7764 -0.675 0.499
Likelihood ratio test=0.46 on 1 df, p=0.4962
n= 24, number of events= 7
============================
TCGA-COAD PTPN18
[1] 32
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.87 0.00592 0.0115
strata=LOW 12 3 3.13 0.00543 0.0115
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.08821 0.91557 0.82236 -0.107 0.915
Likelihood ratio test=0.01 on 1 df, p=0.9146
n= 24, number of events= 6
============================
TCGA-COAD IARS1
[1] 33
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 4.09 0.00187 0.00455
strata=LOW 12 3 2.91 0.00263 0.00455
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.05177 1.05314 0.76775 0.067 0.946
Likelihood ratio test=0 on 1 df, p=0.9463
n= 24, number of events= 7
============================
TCGA-COAD IL4R
[1] 34
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.21 0.192 0.502
strata=LOW 12 2 2.79 0.222 0.502
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6368 0.5290 0.9140 -0.697 0.486
Likelihood ratio test=0.5 on 1 df, p=0.4803
n= 24, number of events= 6
============================
TCGA-COAD SENP1
[1] 35
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.78 0.345 0.853
strata=LOW 12 2 1.22 0.507 0.853
Chisq= 0.9 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.080 2.944 1.226 0.881 0.379
Likelihood ratio test=0.84 on 1 df, p=0.3606
n= 24, number of events= 3
============================
TCGA-COAD IFNA16
============================
TCGA-COAD SOX2
[1] 36
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.93 0.589 0.962
strata=LOW 12 3 4.07 0.280 0.962
Chisq= 1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.8687 0.4195 0.9136 -0.951 0.342
Likelihood ratio test=0.93 on 1 df, p=0.3352
n= 24, number of events= 6
============================
TCGA-COAD LIFR
[1] 37
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.11 0.00414 0.00865
strata=LOW 12 4 3.89 0.00332 0.00865
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.07613 1.07910 0.81855 0.093 0.926
Likelihood ratio test=0.01 on 1 df, p=0.9259
n= 24, number of events= 7
============================
TCGA-COAD MIR199A2
============================
TCGA-COAD COX4I2
[1] 38
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.52 0.872 2.34
strata=LOW 12 1 2.48 0.885 2.34
Chisq= 2.3 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.5967 0.2026 1.1567 -1.38 0.167
Likelihood ratio test=2.28 on 1 df, p=0.1312
n= 24, number of events= 5
============================
TCGA-COAD ATF2
[1] 39
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.53 0.183 0.374
strata=LOW 12 3 2.47 0.113 0.374
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7329 2.0811 1.2252 0.598 0.55
Likelihood ratio test=0.38 on 1 df, p=0.5374
n= 24, number of events= 4
============================
TCGA-COAD ABCC5
[1] 40
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.46 0.0861 0.187
strata=LOW 12 4 3.54 0.0599 0.187
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.4106 1.5077 0.9546 0.43 0.667
Likelihood ratio test=0.19 on 1 df, p=0.6646
n= 24, number of events= 6
============================
TCGA-COAD CCDC6
[1] 41
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.97 0.781 2.32
strata=LOW 12 5 3.03 1.282 2.32
Chisq= 2.3 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.2124 3.3615 0.8437 1.437 0.151
Likelihood ratio test=2.32 on 1 df, p=0.1277
n= 24, number of events= 8
============================
TCGA-COAD OTUB1
[1] 42
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.63 0.0864 0.189
strata=LOW 12 1 1.37 0.1022 0.189
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.5262 0.5908 1.2252 -0.429 0.668
Likelihood ratio test=0.19 on 1 df, p=0.66
n= 24, number of events= 3
============================
TCGA-COAD ALOXE3
[1] 43
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 4.77 0.0109 0.0265
strata=LOW 12 4 4.23 0.0123 0.0265
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1161 0.8904 0.7138 -0.163 0.871
Likelihood ratio test=0.03 on 1 df, p=0.8708
n= 24, number of events= 9
============================
TCGA-COAD SCP2
[1] 44
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.65 0.114 0.565
strata=LOW 12 2 1.35 0.308 0.565
Chisq= 0.6 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.8936 2.4440 1.2285 0.727 0.467
Likelihood ratio test=0.57 on 1 df, p=0.4516
n= 24, number of events= 5
============================
TCGA-COAD PHKG2
[1] 45
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.95 0.000939 0.0019
strata=LOW 12 3 3.05 0.000906 0.0019
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.0362 0.9644 0.8296 -0.044 0.965
Likelihood ratio test=0 on 1 df, p=0.9652
n= 24, number of events= 6
============================
TCGA-COAD MTDH
[1] 46
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.6 0.137 0.296
strata=LOW 12 4 3.4 0.105 0.296
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5006 1.6497 0.9286 0.539 0.59
Likelihood ratio test=0.3 on 1 df, p=0.5857
n= 24, number of events= 6
============================
TCGA-COAD ACO1
[1] 47
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 0.9 0.01111 0.0204
strata=LOW 12 2 2.1 0.00476 0.0204
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2027 0.8165 1.4215 -0.143 0.887
Likelihood ratio test=0.02 on 1 df, p=0.8867
n= 24, number of events= 3
============================
TCGA-COAD MIR137
============================
TCGA-COAD OIP5-AS1
[1] 48
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.87 0.00837 0.0158
strata=LOW 12 3 3.13 0.00502 0.0158
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1257 0.8819 1.0010 -0.126 0.9
Likelihood ratio test=0.02 on 1 df, p=0.9001
n= 24, number of events= 5
============================
TCGA-COAD MIR494
============================
TCGA-COAD MLLT1
[1] 49
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3 7.57e-06 1.6e-05
strata=LOW 12 3 3 7.55e-06 1.6e-05
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.003356 0.996649 0.839511 -0.004 0.997
Likelihood ratio test=0 on 1 df, p=0.9968
n= 24, number of events= 6
============================
TCGA-COAD MIR19B1
============================
TCGA-COAD RPTOR
[1] 50
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.25 0.251 0.471
strata=LOW 12 2 2.75 0.205 0.471
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6268 0.5343 0.9265 -0.676 0.499
Likelihood ratio test=0.47 on 1 df, p=0.4935
n= 24, number of events= 5
============================
TCGA-COAD GCH1
[1] 51
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 4.68 0.0223 0.0842
strata=LOW 12 2 2.32 0.0449 0.0842
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2647 0.7674 0.9149 -0.289 0.772
Likelihood ratio test=0.08 on 1 df, p=0.7707
n= 24, number of events= 7
============================
TCGA-COAD PARP16
[1] 52
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.78 0.661 2.32
strata=LOW 12 4 2.22 1.421 2.32
Chisq= 2.3 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.2661 3.5471 0.8824 1.435 0.151
Likelihood ratio test=2.23 on 1 df, p=0.1355
n= 24, number of events= 7
============================
TCGA-COAD MIR9-3
============================
TCGA-COAD CISD3
[1] 53
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.63 0.0527 0.0942
strata=LOW 12 3 3.37 0.0411 0.0942
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2505 0.7784 0.8182 -0.306 0.76
Likelihood ratio test=0.09 on 1 df, p=0.7598
n= 24, number of events= 6
============================
TCGA-COAD USP35
[1] 54
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.3 0.0392 0.0759
strata=LOW 12 4 3.7 0.0243 0.0759
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2561 1.2919 0.9317 0.275 0.783
Likelihood ratio test=0.08 on 1 df, p=0.7821
n= 24, number of events= 6
============================
TCGA-COAD PRKAA1
[1] 55
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.09 0.57 1.2
strata=LOW 12 4 2.91 0.41 1.2
Chisq= 1.2 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.194 3.299 1.156 1.033 0.302
Likelihood ratio test=1.24 on 1 df, p=0.2651
n= 24, number of events= 5
============================
TCGA-COAD MAPK14
[1] 56
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 1.83 1.83 3.45
strata=LOW 12 5 3.17 1.05 3.45
Chisq= 3.5 on 1 degrees of freedom, p= 0.06
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.110e+01 1.459e+09 2.039e+04 0.001 0.999
Likelihood ratio test=4.96 on 1 df, p=0.02587
n= 24, number of events= 5
============================
TCGA-COAD GRIA3
[1] 57
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.74 0.0177 0.0381
strata=LOW 12 3 3.26 0.0203 0.0381
Chisq= 0 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1492 0.8614 0.7649 -0.195 0.845
Likelihood ratio test=0.04 on 1 df, p=0.8448
n= 24, number of events= 7
============================
TCGA-COAD KDM5C
[1] 58
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.37 0.560 1.13
strata=LOW 12 6 4.63 0.408 1.13
Chisq= 1.1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.8771 2.4039 0.8501 1.032 0.302
Likelihood ratio test=1.17 on 1 df, p=0.2799
n= 24, number of events= 8
============================
TCGA-COAD DECR1
[1] 59
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.36 0.121 0.281
strata=LOW 12 2 2.64 0.155 0.281
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4583 0.6323 0.8723 -0.525 0.599
Likelihood ratio test=0.29 on 1 df, p=0.5916
n= 24, number of events= 6
============================
TCGA-COAD VCP
[1] 60
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.3 0.21 0.403
strata=LOW 12 2 2.7 0.18 0.403
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.5817 0.5590 0.9276 -0.627 0.531
Likelihood ratio test=0.4 on 1 df, p=0.5257
n= 24, number of events= 5
============================
TCGA-COAD MIR129-1
============================
TCGA-COAD PARP10
[1] 61
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.021 0.000147 0.000916
strata=LOW 12 1 0.979 0.000453 0.000916
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.04351 1.04447 1.43744 0.03 0.976
Likelihood ratio test=0 on 1 df, p=0.9759
n= 24, number of events= 4
============================
TCGA-COAD ULK2
[1] 62
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.14 0.01823 0.0306
strata=LOW 12 3 2.86 0.00731 0.0306
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2175 1.2430 1.2458 0.175 0.861
Likelihood ratio test=0.03 on 1 df, p=0.86
n= 24, number of events= 4
============================
TCGA-COAD CISD1
[1] 63
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.86 0.395 0.751
strata=LOW 12 3 2.14 0.342 0.751
Chisq= 0.8 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.9706 2.6395 1.1628 0.835 0.404
Likelihood ratio test=0.79 on 1 df, p=0.3732
n= 24, number of events= 4
============================
TCGA-COAD MIR147A
============================
TCGA-COAD BBOX1-AS1
[1] 64
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.89 0.00328 0.00745
strata=LOW 12 3 3.11 0.00410 0.00745
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.06623 0.93592 0.76737 -0.086 0.931
Likelihood ratio test=0.01 on 1 df, p=0.9311
n= 24, number of events= 7
============================
TCGA-COAD RB1
[1] 65
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.79 0.349 0.865
strata=LOW 12 3 2.21 0.282 0.865
Chisq= 0.9 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.086 2.961 1.225 0.886 0.376
Likelihood ratio test=0.85 on 1 df, p=0.3576
n= 24, number of events= 4
============================
TCGA-COAD TTPA
[1] 66
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.88 0.410 0.688
strata=LOW 12 5 4.12 0.187 0.688
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.9114 2.4879 1.1340 0.804 0.422
Likelihood ratio test=0.75 on 1 df, p=0.3859
n= 24, number of events= 6
============================
TCGA-COAD CDC25A
[1] 67
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.56 0.0769 0.28
strata=LOW 12 1 1.44 0.1362 0.28
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6564 0.5187 1.2600 -0.521 0.602
Likelihood ratio test=0.29 on 1 df, p=0.593
n= 24, number of events= 4
============================
TCGA-COAD PCAT1
[1] 68
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 3.17 1.49 4.11
strata=LOW 12 5 2.83 1.67 4.11
Chisq= 4.1 on 1 degrees of freedom, p= 0.04
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.956 7.074 1.122 1.744 0.0812
Likelihood ratio test=4 on 1 df, p=0.04557
n= 24, number of events= 6
============================
TCGA-COAD DAZAP1
[1] 69
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 4.42 0.0406 0.24
strata=LOW 12 2 1.58 0.1139 0.24
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5923 1.8081 1.2257 0.483 0.629
Likelihood ratio test=0.25 on 1 df, p=0.6198
n= 24, number of events= 6
============================
TCGA-COAD PEX2
[1] 70
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.25 0.249 0.46
strata=LOW 12 3 3.75 0.149 0.46
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6149 0.5407 0.9205 -0.668 0.504
Likelihood ratio test=0.46 on 1 df, p=0.4986
n= 24, number of events= 6
============================
TCGA-COAD MIR124-3
============================
TCGA-COAD TRIM21
[1] 71
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.04 0.267 0.74
strata=LOW 12 4 2.96 0.364 0.74
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7380 2.0918 0.8761 0.842 0.4
Likelihood ratio test=0.75 on 1 df, p=0.3858
n= 24, number of events= 7
============================
TCGA-COAD MEG3
[1] 72
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.35 0.179 0.341
strata=LOW 12 3 3.65 0.115 0.341
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.5288 0.5893 0.9160 -0.577 0.564
Likelihood ratio test=0.34 on 1 df, p=0.5591
n= 24, number of events= 6
============================
TCGA-COAD GCLC
[1] 73
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.118 0.59 2.54
strata=LOW 12 2 0.882 1.42 2.54
Chisq= 2.5 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.146e+01 2.099e+09 2.877e+04 0.001 0.999
Likelihood ratio test=3.28 on 1 df, p=0.07033
n= 24, number of events= 3
============================
TCGA-COAD IDH2
[1] 74
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.94 0.952 3.83
strata=LOW 12 4 2.06 1.816 3.83
Chisq= 3.8 on 1 degrees of freedom, p= 0.05
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.119e+01 1.602e+09 2.022e+04 0.001 0.999
Likelihood ratio test=5.37 on 1 df, p=0.02045
n= 24, number of events= 6
============================
TCGA-COAD FNDC5
[1] 75
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.1 0.00292 0.00624
strata=LOW 12 4 3.9 0.00231 0.00624
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.06562 1.06782 0.83080 0.079 0.937
Likelihood ratio test=0.01 on 1 df, p=0.9371
n= 24, number of events= 7
============================
TCGA-COAD FANCD2
[1] 76
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.144 0.61 2.67
strata=LOW 12 2 0.856 1.53 2.67
Chisq= 2.7 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.153e+01 2.248e+09 2.897e+04 0.001 0.999
Likelihood ratio test=3.4 on 1 df, p=0.06534
n= 24, number of events= 3
============================
TCGA-COAD LCN2
[1] 77
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.03 0.309 0.659
strata=LOW 12 2 2.97 0.316 0.659
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7034 0.4949 0.8826 -0.797 0.425
Likelihood ratio test=0.67 on 1 df, p=0.4132
n= 24, number of events= 6
============================
TCGA-COAD TFR2
[1] 78
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.36 0.0395 0.117
strata=LOW 12 3 2.64 0.0504 0.117
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3265 1.3861 0.9587 0.341 0.733
Likelihood ratio test=0.12 on 1 df, p=0.7311
n= 24, number of events= 6
============================
TCGA-COAD PARP12
[1] 79
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.32 0.522 1.4
strata=LOW 12 4 2.68 0.645 1.4
Chisq= 1.4 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.247 3.479 1.121 1.112 0.266
Likelihood ratio test=1.52 on 1 df, p=0.2173
n= 24, number of events= 6
============================
TCGA-COAD NR1D1
[1] 80
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.91 0.302 0.788
strata=LOW 12 2 3.09 0.382 0.788
Chisq= 0.8 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7515 0.4717 0.8664 -0.867 0.386
Likelihood ratio test=0.8 on 1 df, p=0.3709
n= 24, number of events= 7
============================
TCGA-COAD ATG13
[1] 81
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.82 0.0183 0.0469
strata=LOW 12 1 1.18 0.0282 0.0469
Chisq= 0 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2656 0.7668 1.2294 -0.216 0.829
Likelihood ratio test=0.05 on 1 df, p=0.8267
n= 24, number of events= 3
============================
TCGA-COAD TMSB4X
[1] 82
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.78 0.0278 0.0696
strata=LOW 12 1 1.22 0.0404 0.0696
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3247 0.7227 1.2363 -0.263 0.793
Likelihood ratio test=0.07 on 1 df, p=0.7896
n= 24, number of events= 3
============================
TCGA-COAD CDK14
[1] 83
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.2 0.287 0.645
strata=LOW 12 1 1.8 0.353 0.645
Chisq= 0.6 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9003 0.4064 1.1583 -0.777 0.437
Likelihood ratio test=0.68 on 1 df, p=0.4083
n= 24, number of events= 4
============================
TCGA-COAD RP1-228H13.5
[1] 84
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.25 0.368 1.07
strata=LOW 12 4 2.75 0.568 1.07
Chisq= 1.1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.8785 2.4072 0.8746 1.004 0.315
Likelihood ratio test=1.08 on 1 df, p=0.2991
n= 24, number of events= 7
============================
TCGA-COAD NOX3
============================
TCGA-COAD IFNA17
============================
TCGA-COAD ALOX12B
[1] 85
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.94 0.576 0.889
strata=LOW 12 3 4.06 0.276 0.889
Chisq= 0.9 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7715 0.4623 0.8362 -0.923 0.356
Likelihood ratio test=0.83 on 1 df, p=0.3614
n= 24, number of events= 6
============================
TCGA-COAD PGRMC1
[1] 86
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.45 0.470 1.9
strata=LOW 12 4 2.55 0.819 1.9
Chisq= 1.9 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.1137 3.0455 0.8454 1.317 0.188
Likelihood ratio test=1.67 on 1 df, p=0.1958
n= 24, number of events= 7
============================
TCGA-COAD ULK1
[1] 87
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.89 0.646 1.25
strata=LOW 12 1 2.11 0.581 1.25
Chisq= 1.3 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.2270 0.2932 1.1626 -1.055 0.291
Likelihood ratio test=1.3 on 1 df, p=0.2551
n= 24, number of events= 4
============================
TCGA-COAD TRIM26
[1] 88
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.33 0.0320 0.117
strata=LOW 12 2 1.67 0.0636 0.117
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3544 1.4253 1.0400 0.341 0.733
Likelihood ratio test=0.12 on 1 df, p=0.7335
n= 24, number of events= 5
============================
TCGA-COAD QSOX1
[1] 89
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.12 0.00426 0.00911
strata=LOW 12 3 2.88 0.00460 0.00911
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.07898 1.08219 0.82784 0.095 0.924
Likelihood ratio test=0.01 on 1 df, p=0.924
n= 24, number of events= 6
============================
TCGA-COAD ATM
[1] 90
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.28 0.498 0.967
strata=LOW 12 5 3.72 0.438 0.967
Chisq= 1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.8106 2.2492 0.8456 0.959 0.338
Likelihood ratio test=1 on 1 df, p=0.3166
n= 24, number of events= 7
============================
TCGA-COAD MIB2
[1] 91
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.85 0.468 0.933
strata=LOW 12 2 3.15 0.422 0.933
Chisq= 0.9 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.8303 0.4359 0.8818 -0.942 0.346
Likelihood ratio test=0.94 on 1 df, p=0.3318
n= 24, number of events= 6
============================
TCGA-COAD SLC1A5
[1] 92
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 2.73 1.88 3.55
strata=LOW 12 2 4.27 1.20 3.55
Chisq= 3.5 on 1 degrees of freedom, p= 0.06
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.8284 0.1607 1.1034 -1.657 0.0975
Likelihood ratio test=3.76 on 1 df, p=0.05234
n= 24, number of events= 7
============================
TCGA-COAD MIR2115
============================
TCGA-COAD LINC00336
[1] 93
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.66 0.488 1.47
strata=LOW 12 1 2.34 0.765 1.47
Chisq= 1.5 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.2755 0.2793 1.1240 -1.135 0.256
Likelihood ratio test=1.58 on 1 df, p=0.2081
n= 24, number of events= 6
============================
TCGA-COAD NDRG1
[1] 94
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.41 0.103 0.25
strata=LOW 12 2 2.59 0.135 0.25
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4387 0.6449 0.8845 -0.496 0.62
Likelihood ratio test=0.26 on 1 df, p=0.6133
n= 24, number of events= 6
============================
TCGA-COAD TAFAZZIN
[1] 95
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.37 0.0404 0.149
strata=LOW 12 2 1.63 0.0835 0.149
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3943 1.4834 1.0286 0.383 0.701
Likelihood ratio test=0.15 on 1 df, p=0.7021
n= 24, number of events= 5
============================
TCGA-COAD MIR135B
============================
TCGA-COAD GLS2
[1] 96
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.33 0.1335 0.234
strata=LOW 12 5 5.67 0.0785 0.234
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3442 0.7088 0.7154 -0.481 0.63
Likelihood ratio test=0.23 on 1 df, p=0.6311
n= 24, number of events= 9
============================
TCGA-COAD HELLS
[1] 97
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.73 0.802 4.09
strata=LOW 12 3 1.27 2.352 4.09
Chisq= 4.1 on 1 degrees of freedom, p= 0.04
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.156e+01 2.305e+09 2.372e+04 0.001 0.999
Likelihood ratio test=5.16 on 1 df, p=0.02312
n= 24, number of events= 5
============================
TCGA-COAD KLF2
[1] 98
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.72 0.606 1.76
strata=LOW 12 1 2.28 0.721 1.76
Chisq= 1.8 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.4562 0.2331 1.1827 -1.231 0.218
Likelihood ratio test=1.79 on 1 df, p=0.1814
n= 24, number of events= 5
============================
TCGA-COAD TFAP2A
[1] 99
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.09 0.00284 0.0129
strata=LOW 12 2 1.91 0.00461 0.0129
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1402 1.1505 1.2356 0.113 0.91
Likelihood ratio test=0.01 on 1 df, p=0.909
n= 24, number of events= 5
============================
TCGA-COAD FURIN
[1] 100
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.08 0.00525 0.00821
strata=LOW 12 2 1.92 0.00294 0.00821
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.111 1.117 1.226 0.091 0.928
Likelihood ratio test=0.01 on 1 df, p=0.9274
n= 24, number of events= 3
============================
TCGA-COAD CDH1
[1] 101
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.07 0.555 1.19
strata=LOW 12 5 3.93 0.293 1.19
Chisq= 1.2 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.203 3.331 1.167 1.031 0.302
Likelihood ratio test=1.23 on 1 df, p=0.267
n= 24, number of events= 6
============================
TCGA-COAD MIR6852
============================
TCGA-COAD MIR670
============================
TCGA-COAD TYRO3
[1] 102
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.11 0.586 1.81
strata=LOW 12 3 1.89 0.657 1.81
Chisq= 1.8 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.082e+01 1.097e+09 2.452e+04 0.001 0.999
Likelihood ratio test=2.82 on 1 df, p=0.09325
n= 24, number of events= 4
============================
TCGA-COAD MIR4715
============================
TCGA-COAD ABHD12
[1] 103
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.46 0.198 0.388
strata=LOW 12 2 2.54 0.114 0.388
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7476 0.4735 1.2277 -0.609 0.543
Likelihood ratio test=0.39 on 1 df, p=0.53
n= 24, number of events= 4
============================
TCGA-COAD ATG7
[1] 104
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.57 0.537 1.72
strata=LOW 12 4 2.43 1.007 1.72
Chisq= 1.7 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.0887 2.9704 0.8712 1.25 0.211
Likelihood ratio test=1.68 on 1 df, p=0.1947
n= 24, number of events= 7
============================
TCGA-COAD MT1G
[1] 105
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.49 0.159 0.252
strata=LOW 12 4 3.51 0.067 0.252
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5724 1.7725 1.1550 0.496 0.62
Likelihood ratio test=0.27 on 1 df, p=0.6049
n= 24, number of events= 5
============================
TCGA-COAD SAT1
[1] 106
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.92 0.00303 0.0085
strata=LOW 12 3 3.08 0.00190 0.0085
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1131 0.8931 1.2276 -0.092 0.927
Likelihood ratio test=0.01 on 1 df, p=0.9262
n= 24, number of events= 5
============================
TCGA-COAD MIR182
============================
TCGA-COAD HOTAIR
[1] 107
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 5.57 0.443 1.47
strata=LOW 16 5 3.43 0.720 1.47
Chisq= 1.5 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.0042 2.7299 0.8578 1.171 0.242
Likelihood ratio test=1.52 on 1 df, p=0.2172
n= 28, number of events= 9
============================
TCGA-COAD PIR
[1] 108
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.17 0.318 0.705
strata=LOW 12 2 2.83 0.244 0.705
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9403 0.3905 1.1602 -0.81 0.418
Likelihood ratio test=0.75 on 1 df, p=0.3879
n= 24, number of events= 5
============================
TCGA-COAD ELAVL1
[1] 109
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 4.62 0.0836 0.311
strata=LOW 12 3 2.38 0.1623 0.311
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5053 1.6576 0.9152 0.552 0.581
Likelihood ratio test=0.31 on 1 df, p=0.5764
n= 24, number of events= 7
============================
TCGA-COAD ACADSB
[1] 110
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.53 0.925 3.12
strata=LOW 12 3 1.47 1.591 3.12
Chisq= 3.1 on 1 degrees of freedom, p= 0.08
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.124e+01 1.685e+09 2.322e+04 0.001 0.999
Likelihood ratio test=4.28 on 1 df, p=0.03856
n= 24, number of events= 4
============================
TCGA-COAD NCOA4
[1] 111
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 1.36 1.359 2.48
strata=LOW 12 4 2.64 0.699 2.48
Chisq= 2.5 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.103e+01 1.358e+09 2.337e+04 0.001 0.999
Likelihood ratio test=3.62 on 1 df, p=0.05708
n= 24, number of events= 4
============================
TCGA-COAD IFNA10
============================
TCGA-COAD IFNA13
============================
TCGA-COAD MIR9-2
============================
TCGA-COAD RRM2
[1] 112
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.04 0.266 0.716
strata=LOW 12 4 2.96 0.362 0.716
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7180 2.0504 0.8666 0.829 0.407
Likelihood ratio test=0.73 on 1 df, p=0.3931
n= 24, number of events= 7
============================
TCGA-COAD EPSTI1
[1] 113
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 4.93 0.174 0.51
strata=LOW 12 4 3.07 0.279 0.51
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5478 1.7294 0.7756 0.706 0.48
Likelihood ratio test=0.51 on 1 df, p=0.4767
n= 24, number of events= 8
============================
TCGA-COAD LINC00551
[1] 114
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.29 0.0358 0.0697
strata=LOW 12 3 2.71 0.0302 0.0697
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2471 1.2804 0.9384 0.263 0.792
Likelihood ratio test=0.07 on 1 df, p=0.7909
n= 24, number of events= 5
============================
TCGA-COAD SLC25A28
[1] 115
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.33 0.191 0.601
strata=LOW 12 1 1.67 0.267 0.601
Chisq= 0.6 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9171 0.3997 1.2250 -0.749 0.454
Likelihood ratio test=0.6 on 1 df, p=0.4382
n= 24, number of events= 4
============================
TCGA-COAD LINC00973
============================
TCGA-COAD MIR378A
============================
TCGA-COAD MGST1
[1] 116
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.26 0.924 1.8
strata=LOW 12 2 3.74 0.807 1.8
Chisq= 1.8 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.0899 0.3363 0.8486 -1.284 0.199
Likelihood ratio test=1.83 on 1 df, p=0.1756
n= 24, number of events= 7
============================
TCGA-COAD MIB1
[1] 117
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2 3.14e-06 6.29e-06
strata=LOW 12 3 3 2.09e-06 6.29e-06
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.002509 0.997494 1.000630 -0.003 0.998
Likelihood ratio test=0 on 1 df, p=0.998
n= 24, number of events= 5
============================
TCGA-COAD SRC
[1] 118
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.58 1.28 2.19
strata=LOW 12 2 3.42 0.59 2.19
Chisq= 2.2 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.5874 0.2045 1.1749 -1.351 0.177
Likelihood ratio test=2.17 on 1 df, p=0.141
n= 24, number of events= 5
============================
TCGA-COAD ATG5
[1] 119
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 1.77 1.77 4.32
strata=LOW 12 4 2.23 1.40 4.32
Chisq= 4.3 on 1 degrees of freedom, p= 0.04
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.164e+01 2.491e+09 2.394e+04 0.001 0.999
Likelihood ratio test=5.36 on 1 df, p=0.02063
n= 24, number of events= 4
============================
TCGA-COAD ACVR1B
[1] 120
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.84 0.00846 0.0162
strata=LOW 12 4 4.16 0.00579 0.0162
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1041 0.9012 0.8188 -0.127 0.899
Likelihood ratio test=0.02 on 1 df, p=0.8989
n= 24, number of events= 7
============================
TCGA-COAD NT5DC2
[1] 121
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.63 0.0510 0.139
strata=LOW 12 2 2.37 0.0567 0.139
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3715 0.6897 1.0012 -0.371 0.711
Likelihood ratio test=0.14 on 1 df, p=0.7114
n= 24, number of events= 5
============================
TCGA-COAD PIK3CA
[1] 122
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.45 0.0824 0.213
strata=LOW 12 2 1.55 0.1302 0.213
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.4576 1.5803 1.0005 0.457 0.647
Likelihood ratio test=0.21 on 1 df, p=0.6488
n= 24, number of events= 4
============================
TCGA-COAD NUPR1
[1] 123
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.19 0.297 0.67
strata=LOW 12 2 2.81 0.232 0.67
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9201 0.3985 1.1622 -0.792 0.429
Likelihood ratio test=0.71 on 1 df, p=0.3997
n= 24, number of events= 5
============================
TCGA-COAD AKT1S1
[1] 124
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.75 0.565 1.58
strata=LOW 12 1 2.25 0.692 1.58
Chisq= 1.6 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.3507 0.2591 1.1559 -1.169 0.243
Likelihood ratio test=1.61 on 1 df, p=0.2045
n= 24, number of events= 5
============================
TCGA-COAD MIR19A
============================
TCGA-COAD USP7
[1] 125
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.82 0.176 0.403
strata=LOW 12 5 4.18 0.160 0.403
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.4893 1.6311 0.7780 0.629 0.529
Likelihood ratio test=0.4 on 1 df, p=0.5271
n= 24, number of events= 8
============================
TCGA-COAD TMSB4Y
[1] 126
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.36 0.038 0.0905
strata=LOW 18 4 3.64 0.035 0.0905
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2616 1.2989 0.8719 0.3 0.764
Likelihood ratio test=0.09 on 1 df, p=0.7612
n= 30, number of events= 7
============================
TCGA-COAD SIAH2
[1] 127
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.97 0.358 0.711
strata=LOW 12 3 4.03 0.264 0.711
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7155 0.4889 0.8668 -0.825 0.409
Likelihood ratio test=0.72 on 1 df, p=0.3949
n= 24, number of events= 7
============================
TCGA-COAD MIR29A
============================
TCGA-COAD CHAC1
[1] 128
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.43 1.72 2.91
strata=LOW 12 2 3.57 0.69 2.91
Chisq= 2.9 on 1 degrees of freedom, p= 0.09
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.8994 0.1497 1.2324 -1.541 0.123
Likelihood ratio test=2.85 on 1 df, p=0.09116
n= 24, number of events= 5
============================
TCGA-COAD LINC00616
[1] 129
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.13 0.409 0.576
strata=LOW 31 10 8.87 0.144 0.576
Chisq= 0.6 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5868 1.7983 0.7841 0.748 0.454
Likelihood ratio test=0.63 on 1 df, p=0.4274
n= 43, number of events= 12
============================
TCGA-COAD PRKAA2
[1] 130
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.88 0.00711 0.0137
strata=LOW 12 5 5.12 0.00262 0.0137
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1181 0.8886 1.0096 -0.117 0.907
Likelihood ratio test=0.01 on 1 df, p=0.9069
n= 24, number of events= 7
============================
TCGA-COAD LONP1
[1] 131
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.24 0.256 0.488
strata=LOW 12 2 2.76 0.208 0.488
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6407 0.5269 0.9311 -0.688 0.491
Likelihood ratio test=0.48 on 1 df, p=0.4867
n= 24, number of events= 5
============================
TCGA-COAD PPARG
[1] 132
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.85 0.01223 0.032
strata=LOW 12 3 3.15 0.00718 0.032
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2187 0.8036 1.2258 -0.178 0.858
Likelihood ratio test=0.03 on 1 df, p=0.8568
n= 24, number of events= 5
============================
TCGA-COAD MAPK1
[1] 133
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.21 0.660 1.2
strata=LOW 12 4 2.79 0.522 1.2
Chisq= 1.2 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.167 3.213 1.124 1.039 0.299
Likelihood ratio test=1.31 on 1 df, p=0.2523
n= 24, number of events= 5
============================
TCGA-COAD PEX6
[1] 134
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.61 0.143 0.254
strata=LOW 12 5 4.39 0.085 0.254
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.4339 1.5433 0.8677 0.5 0.617
Likelihood ratio test=0.26 on 1 df, p=0.6097
n= 24, number of events= 7
============================
TCGA-COAD PPARA
[1] 135
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 5.33 0.330 0.937
strata=LOW 12 5 3.67 0.479 0.937
Chisq= 0.9 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7083 2.0305 0.7453 0.95 0.342
Likelihood ratio test=0.93 on 1 df, p=0.3341
n= 24, number of events= 9
============================
TCGA-COAD ACSL4
[1] 136
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.93 0.944 2.53
strata=LOW 12 5 3.07 1.205 2.53
Chisq= 2.5 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.584 4.874 1.101 1.439 0.15
Likelihood ratio test=2.76 on 1 df, p=0.09639
n= 24, number of events= 7
============================
TCGA-COAD ANO6
[1] 137
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.12 0.00697 0.0132
strata=LOW 12 3 2.88 0.00513 0.0132
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1095 1.1157 0.9527 0.115 0.909
Likelihood ratio test=0.01 on 1 df, p=0.9083
n= 24, number of events= 5
============================
TCGA-COAD YTHDC2
[1] 138
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 4.18 1.14 3.28
strata=LOW 12 5 2.82 1.70 3.28
Chisq= 3.3 on 1 degrees of freedom, p= 0.07
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.771 5.880 1.104 1.605 0.109
Likelihood ratio test=3.51 on 1 df, p=0.06096
n= 24, number of events= 7
============================
TCGA-COAD MIR103A1
============================
TCGA-COAD INTS2
[1] 139
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.42 0.829 2.79
strata=LOW 12 3 1.58 1.264 2.79
Chisq= 2.8 on 1 degrees of freedom, p= 0.09
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.119e+01 1.593e+09 2.359e+04 0.001 0.999
Likelihood ratio test=3.93 on 1 df, p=0.04751
n= 24, number of events= 4
============================
TCGA-COAD PTPN6
[1] 140
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.14 0.237 0.766
strata=LOW 12 1 1.86 0.400 0.766
Chisq= 0.8 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9809 0.3750 1.1638 -0.843 0.399
Likelihood ratio test=0.81 on 1 df, p=0.3687
n= 24, number of events= 5
============================
TCGA-COAD SMAD7
[1] 141
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.37 0.0591 0.113
strata=LOW 12 3 2.63 0.0535 0.113
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3058 1.3578 0.9138 0.335 0.738
Likelihood ratio test=0.11 on 1 df, p=0.7358
n= 24, number of events= 5
============================
TCGA-COAD ATG16L1
[1] 142
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 4.53 1.41 3.7
strata=LOW 12 6 3.47 1.84 3.7
Chisq= 3.7 on 1 degrees of freedom, p= 0.05
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.827 6.212 1.083 1.686 0.0918
Likelihood ratio test=4.09 on 1 df, p=0.04309
n= 24, number of events= 8
============================
TCGA-COAD LINC00976
[1] 143
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.08 0.00217 0.00448
strata=LOW 12 4 3.92 0.00171 0.00448
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.05469 1.05621 0.81723 0.067 0.947
Likelihood ratio test=0 on 1 df, p=0.9466
n= 24, number of events= 7
============================
TCGA-COAD H19
[1] 144
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.32 0.0439 0.0821
strata=LOW 12 3 2.68 0.0380 0.0821
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2611 1.2983 0.9137 0.286 0.775
Likelihood ratio test=0.08 on 1 df, p=0.7735
n= 24, number of events= 5
============================
TCGA-COAD FADS1
[1] 145
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.41 1.044 1.81
strata=LOW 12 4 5.59 0.451 1.81
Chisq= 1.8 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.1392 0.3201 0.8876 -1.283 0.199
Likelihood ratio test=1.78 on 1 df, p=0.1821
n= 24, number of events= 8
============================
TCGA-COAD CHP1
[1] 146
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.68 0.0388 0.0851
strata=LOW 12 3 3.32 0.0313 0.0851
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2682 0.7648 0.9218 -0.291 0.771
Likelihood ratio test=0.09 on 1 df, p=0.7694
n= 24, number of events= 6
============================
TCGA-COAD PRR5
[1] 147
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.2 1.48 4.53
strata=LOW 12 0 1.8 1.80 4.53
Chisq= 4.5 on 1 degrees of freedom, p= 0.03
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.170e+01 3.768e-10 2.416e+04 -0.001 0.999
Likelihood ratio test=5.52 on 1 df, p=0.01875
n= 24, number of events= 4
============================
TCGA-COAD CFL1
[1] 148
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.53 0.0860 0.174
strata=LOW 12 2 2.47 0.0883 0.174
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3791 0.6845 0.9132 -0.415 0.678
Likelihood ratio test=0.18 on 1 df, p=0.6751
n= 24, number of events= 5
============================
TCGA-COAD MIR382
============================
TCGA-COAD LAMP2
[1] 149
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.93 0.00230 0.00678
strata=LOW 12 1 1.07 0.00417 0.00678
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1032 0.9020 1.2535 -0.082 0.934
Likelihood ratio test=0.01 on 1 df, p=0.9341
n= 24, number of events= 3
============================
TCGA-COAD PTPN14
[1] 150
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.98 0.000203 0.000411
strata=LOW 12 4 4.02 0.000150 0.000411
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.01674 0.98340 0.82575 -0.02 0.984
Likelihood ratio test=0 on 1 df, p=0.9838
n= 24, number of events= 7
============================
TCGA-COAD AGPAT3
[1] 151
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.42 0.590 1.64
strata=LOW 12 4 2.58 0.782 1.64
Chisq= 1.6 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.342 3.828 1.125 1.193 0.233
Likelihood ratio test=1.77 on 1 df, p=0.1836
n= 24, number of events= 6
============================
TCGA-COAD STING1
[1] 152
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.28 0.224 0.697
strata=LOW 12 1 1.72 0.298 0.697
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9828 0.3743 1.2251 -0.802 0.422
Likelihood ratio test=0.69 on 1 df, p=0.4056
n= 24, number of events= 4
============================
TCGA-COAD ABCC1
[1] 153
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.94 0.382 0.688
strata=LOW 12 3 4.06 0.277 0.688
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6410 0.5268 0.7842 -0.817 0.414
Likelihood ratio test=0.68 on 1 df, p=0.41
n= 24, number of events= 7
============================
TCGA-COAD IFNA5
============================
TCGA-COAD MIR140
============================
TCGA-COAD MYB
[1] 154
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 4.38 1.29 5.38
strata=LOW 12 4 1.62 3.48 5.38
Chisq= 5.4 on 1 degrees of freedom, p= 0.02
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.224 9.244 1.139 1.952 0.0509
Likelihood ratio test=5.02 on 1 df, p=0.02501
n= 24, number of events= 6
============================
TCGA-COAD IFNA6
============================
TCGA-COAD IFNA14
============================
TCGA-COAD BDNF-AS
[1] 155
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.21 0.193 0.366
strata=LOW 12 5 5.79 0.107 0.366
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4653 0.6280 0.7751 -0.6 0.548
Likelihood ratio test=0.37 on 1 df, p=0.5455
n= 24, number of events= 9
============================
TCGA-COAD TRIB2
[1] 156
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 6 3.86 1.18 2.71
strata=LOW 12 2 4.14 1.10 2.71
Chisq= 2.7 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.2920 0.2747 0.8389 -1.54 0.124
Likelihood ratio test=2.68 on 1 df, p=0.1014
n= 24, number of events= 8
============================
TCGA-COAD MALAT1
[1] 157
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.21 0.666 1.5
strata=LOW 12 5 3.79 0.389 1.5
Chisq= 1.5 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.323 3.755 1.158 1.142 0.253
Likelihood ratio test=1.53 on 1 df, p=0.2156
n= 24, number of events= 6
============================
TCGA-COAD FH
[1] 158
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.85 0.892 2.82
strata=LOW 12 4 2.15 1.602 2.82
Chisq= 2.8 on 1 degrees of freedom, p= 0.09
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.681 5.371 1.120 1.5 0.134
Likelihood ratio test=2.9 on 1 df, p=0.08849
n= 24, number of events= 6
============================
TCGA-COAD PEX10
[1] 159
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.59 0.135 0.288
strata=LOW 12 4 3.41 0.103 0.288
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.4927 1.6367 0.9260 0.532 0.595
Likelihood ratio test=0.29 on 1 df, p=0.5905
n= 24, number of events= 6
============================
TCGA-COAD SCD
[1] 160
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.32 0.0447 0.108
strata=LOW 12 2 1.68 0.0618 0.108
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3296 1.3905 1.0073 0.327 0.743
Likelihood ratio test=0.11 on 1 df, p=0.744
n= 24, number of events= 4
============================
TCGA-COAD FTL
[1] 161
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.01 6.89e-05 0.00018
strata=LOW 12 2 1.99 1.05e-04 0.00018
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.01247 1.01255 0.92985 0.013 0.989
Likelihood ratio test=0 on 1 df, p=0.9893
n= 24, number of events= 5
============================
TCGA-COAD TSC1
[1] 162
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.42 0.0515 0.121
strata=LOW 12 3 2.58 0.0683 0.121
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.284 1.328 0.820 0.346 0.729
Likelihood ratio test=0.12 on 1 df, p=0.7295
n= 24, number of events= 6
============================
TCGA-COAD BRD3
[1] 163
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 4.6 0.0342 0.084
strata=LOW 12 3 3.4 0.0463 0.084
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2153 0.8063 0.7444 -0.289 0.772
Likelihood ratio test=0.08 on 1 df, p=0.7708
n= 24, number of events= 8
============================
TCGA-COAD SLC16A1
[1] 164
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.21 0.0137 0.0362
strata=LOW 12 3 2.79 0.0158 0.0362
Chisq= 0 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1748 1.1911 0.9198 0.19 0.849
Likelihood ratio test=0.04 on 1 df, p=0.8485
n= 24, number of events= 6
============================
TCGA-COAD MIR132
============================
TCGA-COAD MIR375
============================
TCGA-COAD MIOX
[1] 165
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.85 0.465 1.36
strata=LOW 12 1 2.15 0.616 1.36
Chisq= 1.4 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.2683 0.2813 1.1609 -1.092 0.275
Likelihood ratio test=1.39 on 1 df, p=0.2377
n= 24, number of events= 5
============================
TCGA-COAD ATXN8OS
============================
TCGA-COAD KLHDC3
[1] 166
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.51 0.0734 0.154
strata=LOW 12 5 4.49 0.0573 0.154
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3058 1.3578 0.7827 0.391 0.696
Likelihood ratio test=0.15 on 1 df, p=0.6943
n= 24, number of events= 8
============================
TCGA-COAD MICU1
[1] 167
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.55 0.0581 0.172
strata=LOW 12 2 2.45 0.0839 0.172
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3849 0.6805 0.9323 -0.413 0.68
Likelihood ratio test=0.17 on 1 df, p=0.677
n= 24, number of events= 6
============================
TCGA-COAD CBS
[1] 168
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.35 0.126 0.295
strata=LOW 12 3 3.65 0.115 0.295
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4409 0.6435 0.8177 -0.539 0.59
Likelihood ratio test=0.29 on 1 df, p=0.5913
n= 24, number of events= 7
============================
TCGA-COAD HUWE1
[1] 169
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.06 0.00200 0.00426
strata=LOW 12 2 1.94 0.00213 0.00426
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.06626 1.06851 1.01577 0.065 0.948
Likelihood ratio test=0 on 1 df, p=0.948
n= 24, number of events= 4
============================
TCGA-COAD LINC00472
[1] 170
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.57 0.0736 0.152
strata=LOW 12 4 4.43 0.0426 0.152
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3539 0.7019 0.9138 -0.387 0.699
Likelihood ratio test=0.15 on 1 df, p=0.6959
n= 24, number of events= 7
============================
TCGA-COAD FGF21
============================
TCGA-COAD MIR34A
============================
TCGA-COAD IDH1
[1] 171
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.1 0.390 1.01
strata=LOW 12 4 2.9 0.416 1.01
Chisq= 1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.076 2.934 1.124 0.958 0.338
Likelihood ratio test=1.1 on 1 df, p=0.2938
n= 24, number of events= 6
============================
TCGA-COAD GSK3B
[1] 172
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 2.59 2.59 7.45
strata=LOW 12 4 1.41 4.79 7.45
Chisq= 7.5 on 1 degrees of freedom, p= 0.006
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.204e+01 3.738e+09 2.218e+04 0.001 0.999
Likelihood ratio test=8.44 on 1 df, p=0.003673
n= 24, number of events= 4
============================
TCGA-COAD KDM4A
[1] 173
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.47 0.0628 0.293
strata=LOW 12 2 1.53 0.1421 0.293
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.655 1.925 1.230 0.532 0.594
Likelihood ratio test=0.3 on 1 df, p=0.584
n= 24, number of events= 5
============================
TCGA-COAD PEX12
[1] 174
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.97 0.000401 0.000686
strata=LOW 12 4 4.03 0.000196 0.000686
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.02434 0.97595 0.92919 -0.026 0.979
Likelihood ratio test=0 on 1 df, p=0.9791
n= 24, number of events= 6
============================
TCGA-COAD IDO1
[1] 175
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 5.04 0.216 0.659
strata=LOW 12 4 2.96 0.368 0.659
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.6237 1.8659 0.7795 0.8 0.424
Likelihood ratio test=0.65 on 1 df, p=0.42
n= 24, number of events= 8
============================
TCGA-COAD BCAT2
[1] 176
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.89 0.00390 0.00779
strata=LOW 12 3 3.11 0.00363 0.00779
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.07328 0.92934 0.83038 -0.088 0.93
Likelihood ratio test=0.01 on 1 df, p=0.9297
n= 24, number of events= 6
============================
TCGA-COAD ADAM23
[1] 177
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.61 0.059 0.105
strata=LOW 12 4 4.39 0.035 0.105
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2636 0.7683 0.8173 -0.322 0.747
Likelihood ratio test=0.1 on 1 df, p=0.7474
n= 24, number of events= 7
============================
TCGA-COAD PEX3
[1] 178
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.33 0.758 1.82
strata=LOW 12 3 1.67 1.055 1.82
Chisq= 1.8 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.433 4.190 1.156 1.24 0.215
Likelihood ratio test=1.82 on 1 df, p=0.1771
n= 24, number of events= 4
============================
TCGA-COAD ATP5MC3
[1] 179
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.5 0.0994 0.172
strata=LOW 12 5 4.5 0.0551 0.172
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3595 1.4326 0.8705 0.413 0.68
Likelihood ratio test=0.18 on 1 df, p=0.6744
n= 24, number of events= 7
============================
TCGA-COAD AQP5
[1] 180
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.76 0.208 0.474
strata=LOW 12 3 2.24 0.256 0.474
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.6274 1.8727 0.9248 0.678 0.498
Likelihood ratio test=0.47 on 1 df, p=0.4919
n= 24, number of events= 5
============================
TCGA-COAD ADAMTS9-AS1
[1] 181
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 3.3 1.60 3.58
strata=LOW 12 5 2.7 1.96 3.58
Chisq= 3.6 on 1 degrees of freedom, p= 0.06
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.817 6.155 1.097 1.657 0.0975
Likelihood ratio test=3.79 on 1 df, p=0.05144
n= 24, number of events= 6
============================
TCGA-COAD ACSL3
[1] 182
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.66 0.164 0.48
strata=LOW 12 3 2.34 0.186 0.48
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.8017 2.2293 1.1839 0.677 0.498
Likelihood ratio test=0.51 on 1 df, p=0.4761
n= 24, number of events= 5
============================
TCGA-COAD DDR2
[1] 183
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.25 0.0199 0.0437
strata=LOW 12 3 2.75 0.0236 0.0437
Chisq= 0 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1707 1.1861 0.8178 0.209 0.835
Likelihood ratio test=0.04 on 1 df, p=0.8348
n= 24, number of events= 6
============================
TCGA-COAD TERT
[1] 184
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2 0.494 0.745
strata=LOW 12 3 4 0.248 0.745
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6929 0.5001 0.8186 -0.846 0.397
Likelihood ratio test=0.7 on 1 df, p=0.4018
n= 24, number of events= 6
============================
TCGA-COAD IFNA7
============================
TCGA-COAD ECH1
[1] 185
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.81 0.506 0.961
strata=LOW 12 3 4.19 0.339 0.961
Chisq= 1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.8291 0.4364 0.8697 -0.953 0.34
Likelihood ratio test=0.97 on 1 df, p=0.3247
n= 24, number of events= 7
============================
TCGA-COAD CS
[1] 186
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.55 0.0845 0.174
strata=LOW 12 4 3.45 0.0868 0.174
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3193 1.3761 0.7691 0.415 0.678
Likelihood ratio test=0.17 on 1 df, p=0.6764
n= 24, number of events= 7
============================
TCGA-COAD AMN
[1] 187
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.39 1.083 1.81
strata=LOW 12 2 3.61 0.717 1.81
Chisq= 1.8 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.1088 0.3299 0.8675 -1.278 0.201
Likelihood ratio test=1.76 on 1 df, p=0.1844
n= 24, number of events= 6
============================
TCGA-COAD DUOX2
[1] 188
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.45 0.0884 0.181
strata=LOW 12 3 3.55 0.0858 0.181
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3297 0.7192 0.7778 -0.424 0.672
Likelihood ratio test=0.18 on 1 df, p=0.6701
n= 24, number of events= 7
============================
TCGA-COAD MBOAT1
[1] 189
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.85 0.00577 0.0112
strata=LOW 12 5 5.15 0.00431 0.0112
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.07512 0.92763 0.70979 -0.106 0.916
Likelihood ratio test=0.01 on 1 df, p=0.9157
n= 24, number of events= 9
============================
TCGA-COAD RNF113A
[1] 190
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.49 0.103 0.278
strata=LOW 12 1 1.51 0.171 0.278
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6022 0.5476 1.1601 -0.519 0.604
Likelihood ratio test=0.29 on 1 df, p=0.5875
n= 24, number of events= 4
============================
TCGA-COAD MIR138-1
============================
TCGA-COAD MIR144
============================
TCGA-COAD P4HB
[1] 191
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.63 1.160 1.98
strata=LOW 12 2 3.37 0.559 1.98
Chisq= 2 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.4938 0.2245 1.1597 -1.288 0.198
Likelihood ratio test=1.97 on 1 df, p=0.1606
n= 24, number of events= 5
============================
TCGA-COAD MIR338
============================
TCGA-COAD PTGS2
[1] 192
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.97 0.353 0.626
strata=LOW 12 4 5.03 0.209 0.626
Chisq= 0.6 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6013 0.5481 0.7710 -0.78 0.435
Likelihood ratio test=0.62 on 1 df, p=0.4323
n= 24, number of events= 8
============================
TCGA-COAD ASAH2
[1] 193
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.32 0.346 0.621
strata=LOW 12 2 2.68 0.171 0.621
Chisq= 0.6 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9327 0.3935 1.2262 -0.761 0.447
Likelihood ratio test=0.62 on 1 df, p=0.4308
n= 24, number of events= 4
============================
TCGA-COAD MIR522
============================
TCGA-COAD GALNT14
[1] 194
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.45 0.691 2.06
strata=LOW 12 1 2.55 0.938 2.06
Chisq= 2.1 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.4984 0.2235 1.1354 -1.32 0.187
Likelihood ratio test=2.16 on 1 df, p=0.1413
n= 24, number of events= 6
============================
TCGA-COAD KDM4C
[1] 195
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.18 0.01558 0.0344
strata=LOW 12 4 3.82 0.00892 0.0344
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1856 1.2040 1.0017 0.185 0.853
Likelihood ratio test=0.03 on 1 df, p=0.8531
n= 24, number of events= 6
============================
TCGA-COAD FXN
[1] 196
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.27 0.0328 0.102
strata=LOW 12 2 1.73 0.0431 0.102
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3883 1.4745 1.2252 0.317 0.751
Likelihood ratio test=0.1 on 1 df, p=0.7467
n= 24, number of events= 4
============================
TCGA-COAD MEF2C
[1] 197
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.55 0.0842 0.206
strata=LOW 12 4 3.45 0.0864 0.206
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3693 1.4467 0.8176 0.452 0.652
Likelihood ratio test=0.2 on 1 df, p=0.6524
n= 24, number of events= 7
============================
TCGA-COAD MDM2
[1] 198
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.6 0.0622 0.114
strata=LOW 12 3 3.4 0.0475 0.114
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2794 0.7562 0.8317 -0.336 0.737
Likelihood ratio test=0.11 on 1 df, p=0.7372
n= 24, number of events= 6
============================
TCGA-COAD MAP3K14
[1] 199
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.38 0.776 1.82
strata=LOW 12 1 2.62 1.001 1.82
Chisq= 1.8 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.3791 0.2518 1.1023 -1.251 0.211
Likelihood ratio test=2.03 on 1 df, p=0.1544
n= 24, number of events= 6
============================
TCGA-COAD MDM4
[1] 200
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.7 0.779 1.75
strata=LOW 12 5 3.3 0.872 1.75
Chisq= 1.7 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.0767 2.9351 0.8503 1.266 0.205
Likelihood ratio test=1.77 on 1 df, p=0.1828
n= 24, number of events= 7
============================
TCGA-COAD ASMTL-AS1
[1] 201
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.08 0.00234 0.00483
strata=LOW 12 3 2.92 0.00248 0.00483
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.05676 1.05841 0.81725 0.069 0.945
Likelihood ratio test=0 on 1 df, p=0.9446
n= 24, number of events= 6
============================
TCGA-COAD NEAT1
[1] 202
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.72 0.0463 0.0884
strata=LOW 12 2 2.28 0.0349 0.0884
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3098 0.7336 1.0450 -0.296 0.767
Likelihood ratio test=0.09 on 1 df, p=0.7672
n= 24, number of events= 4
============================
TCGA-COAD COPZ1
[1] 203
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.35 0.178 0.337
strata=LOW 12 3 3.65 0.115 0.337
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.5250 0.5915 0.9141 -0.574 0.566
Likelihood ratio test=0.34 on 1 df, p=0.5611
n= 24, number of events= 6
============================
TCGA-COAD PLIN2
[1] 204
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.52 0.0669 0.163
strata=LOW 12 3 3.48 0.0675 0.163
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3488 0.7055 0.8690 -0.401 0.688
Likelihood ratio test=0.17 on 1 df, p=0.6831
n= 24, number of events= 7
============================
TCGA-COAD FADS2
[1] 205
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.59 0.1029 0.185
strata=LOW 12 4 4.41 0.0373 0.185
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4486 0.6385 1.0495 -0.427 0.669
Likelihood ratio test=0.18 on 1 df, p=0.6693
n= 24, number of events= 6
============================
TCGA-COAD MIR7-1
============================
TCGA-COAD TXN
[1] 206
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.93 0.00131 0.00346
strata=LOW 12 3 3.07 0.00168 0.00346
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.04814 0.95300 0.81842 -0.059 0.953
Likelihood ratio test=0 on 1 df, p=0.9531
n= 24, number of events= 7
============================
TCGA-COAD MIR302A
============================
TCGA-COAD EGLN2
[1] 207
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.84 0.185 0.414
strata=LOW 12 4 3.16 0.225 0.414
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.4885 1.6299 0.7670 0.637 0.524
Likelihood ratio test=0.41 on 1 df, p=0.5214
n= 24, number of events= 7
============================
TCGA-COAD NCOA3
[1] 208
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.7 0.133 0.351
strata=LOW 12 3 2.3 0.215 0.351
Chisq= 0.4 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.4818 1.6190 0.8206 0.587 0.557
Likelihood ratio test=0.34 on 1 df, p=0.559
n= 24, number of events= 6
============================
TCGA-COAD SREBF1
[1] 209
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.52 1.433 2.34
strata=LOW 12 1 2.48 0.881 2.34
Chisq= 2.3 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.6009 0.2017 1.1592 -1.381 0.167
Likelihood ratio test=2.28 on 1 df, p=0.1313
n= 24, number of events= 4
============================
TCGA-COAD LINC01134
[1] 210
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.46 0.1171 0.241
strata=LOW 12 3 3.54 0.0815 0.241
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4555 0.6341 0.9339 -0.488 0.626
Likelihood ratio test=0.24 on 1 df, p=0.6221
n= 24, number of events= 6
============================
TCGA-COAD MYCN
[1] 211
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.56 0.124 0.334
strata=LOW 12 3 2.44 0.131 0.334
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.6556 1.9264 1.1549 0.568 0.57
Likelihood ratio test=0.36 on 1 df, p=0.5513
n= 24, number of events= 5
============================
TCGA-COAD IFNA4
============================
TCGA-COAD DPEP1
[1] 212
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.53 0.112 0.228
strata=LOW 12 3 2.47 0.115 0.228
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.4324 1.5410 0.9132 0.474 0.636
Likelihood ratio test=0.23 on 1 df, p=0.6322
n= 24, number of events= 5
============================
TCGA-COAD VDAC2
[1] 213
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.7 0.287 0.505
strata=LOW 12 4 3.3 0.148 0.505
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.8028 2.2318 1.1595 0.692 0.489
Likelihood ratio test=0.54 on 1 df, p=0.4639
n= 24, number of events= 5
============================
TCGA-COAD PCBP2-OT1
[1] 214
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3 0.335 0.689
strata=LOW 12 4 3 0.336 0.689
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7123 2.0387 0.8751 0.814 0.416
Likelihood ratio test=0.7 on 1 df, p=0.4023
n= 24, number of events= 6
============================
TCGA-COAD KEAP1
[1] 215
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.8 0.0139 0.0261
strata=LOW 12 3 3.2 0.0122 0.0261
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1321 0.8762 0.8178 -0.162 0.872
Likelihood ratio test=0.03 on 1 df, p=0.8717
n= 24, number of events= 6
============================
TCGA-COAD RPL8
[1] 216
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.93 0.392 0.775
strata=LOW 12 3 4.07 0.282 0.775
Chisq= 0.8 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7488 0.4730 0.8702 -0.86 0.39
Likelihood ratio test=0.79 on 1 df, p=0.3751
n= 24, number of events= 7
============================
TCGA-COAD ALOX12
[1] 217
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 6 3.03 2.91 6.02
strata=LOW 12 0 2.97 2.97 6.02
Chisq= 6 on 1 degrees of freedom, p= 0.01
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.124e+01 5.971e-10 1.655e+04 -0.001 0.999
Likelihood ratio test=8.32 on 1 df, p=0.003917
n= 24, number of events= 6
============================
TCGA-COAD ACSF2
[1] 218
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.22 0.0215 0.05
strata=LOW 12 2 1.78 0.0267 0.05
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2276 1.2556 1.0198 0.223 0.823
Likelihood ratio test=0.05 on 1 df, p=0.8235
n= 24, number of events= 4
============================
TCGA-COAD KDM5A
[1] 219
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.95 1.29 5.56
strata=LOW 12 3 1.05 3.59 5.56
Chisq= 5.6 on 1 degrees of freedom, p= 0.02
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.202e+01 3.667e+09 2.558e+04 0.001 0.999
Likelihood ratio test=6.3 on 1 df, p=0.01209
n= 24, number of events= 4
============================
TCGA-COAD NRAS
[1] 220
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.59 0.976 2.1
strata=LOW 12 4 2.41 1.048 2.1
Chisq= 2.1 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.497 4.467 1.127 1.328 0.184
Likelihood ratio test=2.21 on 1 df, p=0.1368
n= 24, number of events= 5
============================
TCGA-COAD MIR30E
============================
TCGA-COAD OGFRP1
[1] 221
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.83 0.182 0.435
strata=LOW 12 5 4.17 0.167 0.435
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5557 1.7431 0.8526 0.652 0.515
Likelihood ratio test=0.45 on 1 df, p=0.5014
n= 24, number of events= 8
============================
TCGA-COAD TF
[1] 222
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.47 0.676 1.4
strata=LOW 12 3 4.53 0.518 1.4
Chisq= 1.4 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9798 0.3754 0.8579 -1.142 0.253
Likelihood ratio test=1.45 on 1 df, p=0.2288
n= 24, number of events= 8
============================
TCGA-COAD ETV4
[1] 223
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.5 0.169 0.339
strata=LOW 12 2 1.5 0.170 0.339
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7001 2.0141 1.2262 0.571 0.568
Likelihood ratio test=0.35 on 1 df, p=0.5564
n= 24, number of events= 3
============================
TCGA-COAD PLA2G6
[1] 224
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.7 1.003 1.52
strata=LOW 12 2 3.3 0.515 1.52
Chisq= 1.5 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.0748 0.3414 0.9138 -1.176 0.24
Likelihood ratio test=1.42 on 1 df, p=0.2338
n= 24, number of events= 5
============================
TCGA-COAD POR
[1] 225
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.85 0.0123 0.0465
strata=LOW 12 1 1.15 0.0197 0.0465
Chisq= 0 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3040 0.7379 1.4147 -0.215 0.83
Likelihood ratio test=0.05 on 1 df, p=0.8302
n= 24, number of events= 3
============================
TCGA-COAD BRPF1
[1] 226
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 4.92 0.171 0.698
strata=LOW 12 3 2.08 0.405 0.698
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7476 2.1120 0.9156 0.817 0.414
Likelihood ratio test=0.68 on 1 df, p=0.4079
n= 24, number of events= 7
============================
TCGA-COAD TMBIM4
[1] 227
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.53 0.923 1.66
strata=LOW 12 5 3.47 0.672 1.66
Chisq= 1.7 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.328 3.775 1.105 1.202 0.229
Likelihood ratio test=1.85 on 1 df, p=0.1739
n= 24, number of events= 6
============================
TCGA-COAD KRAS
[1] 228
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.99 0.993 3.3
strata=LOW 12 4 2.01 1.970 3.3
Chisq= 3.3 on 1 degrees of freedom, p= 0.07
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.784 5.955 1.118 1.596 0.111
Likelihood ratio test=3.32 on 1 df, p=0.06859
n= 24, number of events= 6
============================
TCGA-COAD AHCY
[1] 229
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.2 0.0182 0.0337
strata=LOW 12 4 3.8 0.0105 0.0337
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1703 1.1857 0.9290 0.183 0.855
Likelihood ratio test=0.03 on 1 df, p=0.8539
n= 24, number of events= 6
============================
TCGA-COAD MIR34C
============================
TCGA-COAD ATG3
[1] 230
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.33 0.0319 0.0745
strata=LOW 12 4 3.67 0.0288 0.0745
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2267 1.2545 0.8324 0.272 0.785
Likelihood ratio test=0.07 on 1 df, p=0.7856
n= 24, number of events= 7
============================
TCGA-COAD MIR30B
============================
TCGA-COAD LYRM1
[1] 231
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 4.03 1.03 2.79
strata=LOW 12 5 2.97 1.40 2.79
Chisq= 2.8 on 1 degrees of freedom, p= 0.09
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.647 5.190 1.098 1.499 0.134
Likelihood ratio test=3.03 on 1 df, p=0.08159
n= 24, number of events= 7
============================
TCGA-COAD SIRT6
[1] 232
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.72 0.0443 0.111
strata=LOW 12 2 2.28 0.0335 0.111
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4171 0.6590 1.2588 -0.331 0.74
Likelihood ratio test=0.11 on 1 df, p=0.7361
n= 24, number of events= 4
============================
TCGA-COAD KMT2D
[1] 233
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.99 0.344 0.631
strata=LOW 12 3 4.01 0.256 0.631
Chisq= 0.6 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6183 0.5389 0.7892 -0.783 0.433
Likelihood ratio test=0.63 on 1 df, p=0.429
n= 24, number of events= 7
============================
TCGA-COAD LPIN1
[1] 234
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.01 0.340 1.03
strata=LOW 12 3 1.99 0.515 1.03
Chisq= 1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.113 3.043 1.156 0.963 0.336
Likelihood ratio test=1.07 on 1 df, p=0.3002
n= 24, number of events= 5
============================
TCGA-COAD MBOAT2
[1] 235
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.59 0.0660 0.183
strata=LOW 12 2 2.41 0.0708 0.183
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4300 0.6505 1.0133 -0.424 0.671
Likelihood ratio test=0.18 on 1 df, p=0.6723
n= 24, number of events= 5
============================
TCGA-COAD KDM3B
[1] 236
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.6 0.556 1.8
strata=LOW 12 4 2.4 1.066 1.8
Chisq= 1.8 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.1110 3.0374 0.8704 1.276 0.202
Likelihood ratio test=1.76 on 1 df, p=0.1852
n= 24, number of events= 7
============================
TCGA-COAD ARHGEF26-AS1
[1] 237
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.69 0.281 0.486
strata=LOW 13 4 3.31 0.143 0.486
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7858 2.1942 1.1557 0.68 0.497
Likelihood ratio test=0.52 on 1 df, p=0.472
n= 25, number of events= 5
============================
TCGA-COAD MIR9-1
============================
TCGA-COAD AIFM2
[1] 238
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.43 0.135 0.355
strata=LOW 12 2 2.57 0.128 0.355
Chisq= 0.4 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6828 0.5052 1.1674 -0.585 0.559
Likelihood ratio test=0.38 on 1 df, p=0.5396
n= 24, number of events= 5
============================
TCGA-COAD PRDX1
[1] 239
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.77 0.0140 0.0308
strata=LOW 12 3 3.23 0.0163 0.0308
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1352 0.8736 0.7705 -0.175 0.861
Likelihood ratio test=0.03 on 1 df, p=0.8603
n= 24, number of events= 7
============================
TCGA-COAD FOXO4
[1] 240
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.45 0.058 0.217
strata=LOW 12 2 1.55 0.129 0.217
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.4706 1.6010 1.0180 0.462 0.644
Likelihood ratio test=0.21 on 1 df, p=0.6451
n= 24, number of events= 5
============================
TCGA-COAD BMAL1
[1] 241
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.95 0.308 0.755
strata=LOW 12 4 3.05 0.299 0.755
Chisq= 0.8 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7748 2.1701 0.9137 0.848 0.396
Likelihood ratio test=0.74 on 1 df, p=0.3901
n= 24, number of events= 6
============================
TCGA-COAD MIR127
============================
TCGA-COAD TGFBR1
[1] 242
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.23 0.263 0.596
strata=LOW 12 1 1.77 0.332 0.596
Chisq= 0.6 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.8647 0.4212 1.1554 -0.748 0.454
Likelihood ratio test=0.63 on 1 df, p=0.4265
n= 24, number of events= 4
============================
TCGA-COAD NR1D2
[1] 243
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.31 0.0414 0.0982
strata=LOW 12 2 1.69 0.0565 0.0982
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3126 1.3670 1.0015 0.312 0.755
Likelihood ratio test=0.1 on 1 df, p=0.7554
n= 24, number of events= 4
============================
TCGA-COAD FZD7
[1] 244
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.35 2.01 3.66
strata=LOW 12 1 2.65 1.03 3.66
Chisq= 3.7 on 1 degrees of freedom, p= 0.06
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.142e+01 4.986e-10 2.341e+04 -0.001 0.999
Likelihood ratio test=4.78 on 1 df, p=0.02875
n= 24, number of events= 4
============================
TCGA-COAD G6PD
[1] 245
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.45 0.124 0.404
strata=LOW 12 1 1.55 0.195 0.404
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7604 0.4675 1.2250 -0.621 0.535
Likelihood ratio test=0.41 on 1 df, p=0.5219
n= 24, number of events= 4
============================
TCGA-COAD HRAS
[1] 246
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.75 0.565 1.58
strata=LOW 12 1 2.25 0.692 1.58
Chisq= 1.6 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.3507 0.2591 1.1559 -1.169 0.243
Likelihood ratio test=1.61 on 1 df, p=0.2045
n= 24, number of events= 5
============================
TCGA-COAD SLC38A1
[1] 247
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.07 0.00249 0.00517
strata=LOW 12 3 2.93 0.00176 0.00517
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.07191 1.07456 1.00074 0.072 0.943
Likelihood ratio test=0.01 on 1 df, p=0.9427
n= 24, number of events= 5
============================
TCGA-COAD SLC39A14
[1] 248
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.07 0.283 1.2
strata=LOW 12 3 1.93 0.599 1.2
Chisq= 1.2 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.213 3.363 1.170 1.036 0.3
Likelihood ratio test=1.24 on 1 df, p=0.2648
n= 24, number of events= 6
============================
TCGA-COAD MIR21
============================
TCGA-COAD MIR1-1
============================
TCGA-COAD PROM2
[1] 249
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.38 0.0601 0.118
strata=LOW 12 4 3.62 0.0395 0.118
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3164 1.3721 0.9250 0.342 0.732
Likelihood ratio test=0.12 on 1 df, p=0.7302
n= 24, number of events= 6
============================
TCGA-COAD NFE2L2
[1] 250
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.14 0.416 1.35
strata=LOW 12 3 1.86 0.705 1.35
Chisq= 1.3 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.270 3.562 1.164 1.091 0.275
Likelihood ratio test=1.39 on 1 df, p=0.2387
n= 24, number of events= 5
============================
TCGA-COAD GABARAPL1
[1] 251
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 2.68 2.00 3.75
strata=LOW 12 2 4.32 1.24 3.75
Chisq= 3.8 on 1 degrees of freedom, p= 0.05
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.8937 0.1505 1.1130 -1.701 0.0889
Likelihood ratio test=3.98 on 1 df, p=0.04597
n= 24, number of events= 7
============================
TCGA-COAD MIR335
============================
TCGA-COAD PTEN
[1] 252
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2 3.14e-06 6.29e-06
strata=LOW 12 3 3 2.09e-06 6.29e-06
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.002509 0.997494 1.000630 -0.003 0.998
Likelihood ratio test=0 on 1 df, p=0.998
n= 24, number of events= 5
============================
TCGA-COAD PARP4
[1] 253
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.93 0.00289 0.0057
strata=LOW 12 3 3.07 0.00181 0.0057
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.07629 0.92655 1.01091 -0.075 0.94
Likelihood ratio test=0.01 on 1 df, p=0.9398
n= 24, number of events= 5
============================
TCGA-COAD MS4A15
[1] 254
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.42 0.590 1.39
strata=LOW 12 5 3.58 0.564 1.39
Chisq= 1.4 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.9908 2.6934 0.8724 1.136 0.256
Likelihood ratio test=1.38 on 1 df, p=0.2393
n= 24, number of events= 7
============================
TCGA-COAD TIMM9
[1] 255
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.18 0.0148 0.027
strata=LOW 12 3 2.82 0.0114 0.027
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1521 1.1643 0.9261 0.164 0.87
Likelihood ratio test=0.03 on 1 df, p=0.869
n= 24, number of events= 5
============================
TCGA-COAD PARP3
[1] 256
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.06 0.00100 0.00317
strata=LOW 12 2 1.94 0.00158 0.00317
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.05722 1.05889 1.01643 0.056 0.955
Likelihood ratio test=0 on 1 df, p=0.9551
n= 24, number of events= 5
============================
TCGA-COAD WIPI1
[1] 257
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.8 0.382 0.837
strata=LOW 12 3 4.2 0.345 0.837
Chisq= 0.8 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7485 0.4731 0.8373 -0.894 0.371
Likelihood ratio test=0.87 on 1 df, p=0.3503
n= 24, number of events= 8
============================
TCGA-COAD SNX5
[1] 258
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.85 0.00839 0.0162
strata=LOW 12 3 3.15 0.00757 0.0162
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1049 0.9004 0.8238 -0.127 0.899
Likelihood ratio test=0.02 on 1 df, p=0.8986
n= 24, number of events= 6
============================
TCGA-COAD LINC00239
[1] 259
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.38 0.0425 0.0979
strata=LOW 12 3 2.62 0.0549 0.0979
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2555 1.2911 0.8187 0.312 0.755
Likelihood ratio test=0.1 on 1 df, p=0.7553
n= 24, number of events= 6
============================
TCGA-COAD PIEZO1
[1] 260
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 0.865 0.02090 0.0369
strata=LOW 12 2 2.135 0.00848 0.0369
Chisq= 0 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2708 0.7628 1.4146 -0.191 0.848
Likelihood ratio test=0.04 on 1 df, p=0.8484
n= 24, number of events= 3
============================
TCGA-COAD AKR1C2
[1] 261
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.11 0.00371 0.00817
strata=LOW 12 4 3.89 0.00296 0.00817
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.07603 1.07899 0.84119 0.09 0.928
Likelihood ratio test=0.01 on 1 df, p=0.928
n= 24, number of events= 7
============================
TCGA-COAD MIR4443
============================
TCGA-COAD SLC16A1-AS1
[1] 262
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.64 1.02 2.19
strata=LOW 12 4 2.36 1.13 2.19
Chisq= 2.2 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.527 4.604 1.128 1.354 0.176
Likelihood ratio test=2.32 on 1 df, p=0.1277
n= 24, number of events= 5
============================
TCGA-COAD FAR1
[1] 263
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 1.258 1.26 3.4
strata=LOW 12 2 0.742 2.13 3.4
Chisq= 3.4 on 1 degrees of freedom, p= 0.07
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.187e+01 3.159e+09 3.046e+04 0.001 0.999
Likelihood ratio test=3.97 on 1 df, p=0.04627
n= 24, number of events= 2
============================
TCGA-COAD CISD2
[1] 264
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.29 0.220 0.406
strata=LOW 12 2 2.71 0.186 0.406
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.5737 0.5634 0.9133 -0.628 0.53
Likelihood ratio test=0.4 on 1 df, p=0.5247
n= 24, number of events= 5
============================
TCGA-COAD MAPK3
[1] 265
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.54 0.838 1.46
strata=LOW 12 3 4.46 0.477 1.46
Chisq= 1.5 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.0081 0.3649 0.8686 -1.161 0.246
Likelihood ratio test=1.45 on 1 df, p=0.2288
n= 24, number of events= 7
============================
TCGA-COAD CYGB
[1] 266
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.34 0.130 0.26
strata=LOW 12 4 4.66 0.093 0.26
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3957 0.6732 0.7804 -0.507 0.612
Likelihood ratio test=0.26 on 1 df, p=0.6103
n= 24, number of events= 8
============================
TCGA-COAD MLST8
[1] 267
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.03 0.000252 0.000519
strata=LOW 12 3 2.97 0.000256 0.000519
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.01882 1.01900 0.82562 0.023 0.982
Likelihood ratio test=0 on 1 df, p=0.9818
n= 24, number of events= 6
============================
TCGA-COAD PANX2
[1] 268
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.83 0.356 0.918
strata=LOW 12 2 3.17 0.431 0.918
Chisq= 0.9 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.8102 0.4448 0.8683 -0.933 0.351
Likelihood ratio test=0.93 on 1 df, p=0.3352
n= 24, number of events= 7
============================
TCGA-COAD PEBP1
[1] 269
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 4.33 0.103 0.359
strata=LOW 12 2 2.67 0.167 0.359
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.5411 0.5821 0.9135 -0.592 0.554
Likelihood ratio test=0.36 on 1 df, p=0.5488
n= 24, number of events= 7
============================
TCGA-COAD PARP8
[1] 270
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.46 0.862 1.74
strata=LOW 12 4 2.54 0.832 1.74
Chisq= 1.7 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.378 3.966 1.125 1.224 0.221
Likelihood ratio test=1.86 on 1 df, p=0.1723
n= 24, number of events= 5
============================
TCGA-COAD GJA1
[1] 271
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.25 0.942 1.77
strata=LOW 12 3 4.75 0.644 1.77
Chisq= 1.8 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.0661 0.3444 0.8391 -1.27 0.204
Likelihood ratio test=1.8 on 1 df, p=0.1792
n= 24, number of events= 8
============================
TCGA-COAD BAP1
[1] 272
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.39 0.439 0.998
strata=LOW 12 5 3.61 0.532 0.998
Chisq= 1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7270 2.0688 0.7423 0.979 0.327
Likelihood ratio test=1 on 1 df, p=0.3177
n= 24, number of events= 8
============================
TCGA-COAD MAP3K11
[1] 273
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.47 0.112 0.37
strata=LOW 12 1 1.53 0.181 0.37
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7287 0.4825 1.2251 -0.595 0.552
Likelihood ratio test=0.38 on 1 df, p=0.5397
n= 24, number of events= 4
============================
TCGA-COAD TTBK2
[1] 274
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.2 0.202 0.436
strata=LOW 12 3 3.8 0.170 0.436
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.5670 0.5672 0.8700 -0.652 0.515
Likelihood ratio test=0.45 on 1 df, p=0.5038
n= 24, number of events= 7
============================
TCGA-COAD MIR214
============================
TCGA-COAD PARP15
[1] 275
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 5.07 0.228 0.705
strata=LOW 12 4 2.93 0.395 0.705
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.6458 1.9075 0.7811 0.827 0.408
Likelihood ratio test=0.69 on 1 df, p=0.4048
n= 24, number of events= 8
============================
TCGA-COAD HDDC3
[1] 276
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.8 0.01063 0.0204
strata=LOW 12 4 4.2 0.00961 0.0204
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1011 0.9038 0.7091 -0.143 0.887
Likelihood ratio test=0.02 on 1 df, p=0.8866
n= 24, number of events= 8
============================
TCGA-COAD MIR10A
============================
TCGA-COAD CGAS
[1] 277
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.2 0.203 0.344
strata=LOW 12 4 4.8 0.135 0.344
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4164 0.6594 0.7147 -0.583 0.56
Likelihood ratio test=0.34 on 1 df, p=0.5614
n= 24, number of events= 8
============================
TCGA-COAD SIRT2
[1] 278
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.52 0.0898 0.254
strata=LOW 12 2 2.48 0.0916 0.254
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.5831 0.5581 1.1732 -0.497 0.619
Likelihood ratio test=0.27 on 1 df, p=0.6046
n= 24, number of events= 5
============================
TCGA-COAD PPARD
[1] 279
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.91 0.623 1.02
strata=LOW 12 3 4.09 0.291 1.02
Chisq= 1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9001 0.4065 0.9196 -0.979 0.328
Likelihood ratio test=0.98 on 1 df, p=0.3211
n= 24, number of events= 6
============================
TCGA-COAD EGR1
[1] 280
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.17 0.220 0.414
strata=LOW 12 4 4.83 0.144 0.414
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4954 0.6094 0.7770 -0.638 0.524
Likelihood ratio test=0.41 on 1 df, p=0.5207
n= 24, number of events= 8
============================
TCGA-COAD AQP3
[1] 281
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.79 0.166 0.441
strata=LOW 12 4 3.21 0.196 0.441
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5807 1.7873 0.8853 0.656 0.512
Likelihood ratio test=0.45 on 1 df, p=0.5013
n= 24, number of events= 7
============================
TCGA-COAD HSF1
[1] 282
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.44 0.126 0.413
strata=LOW 12 1 1.56 0.199 0.413
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7680 0.4639 1.2251 -0.627 0.531
Likelihood ratio test=0.42 on 1 df, p=0.5177
n= 24, number of events= 4
============================
TCGA-COAD MIR18A
============================
TCGA-COAD OSBPL9
[1] 283
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.97 0.000377 0.000759
strata=LOW 12 2 2.03 0.000366 0.000759
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.02785 0.97253 1.01083 -0.028 0.978
Likelihood ratio test=0 on 1 df, p=0.978
n= 24, number of events= 4
============================
TCGA-COAD SESN2
[1] 284
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.24 1.376 2.63
strata=LOW 12 2 3.76 0.821 2.63
Chisq= 2.6 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.655 0.191 1.131 -1.464 0.143
Likelihood ratio test=2.72 on 1 df, p=0.09928
n= 24, number of events= 6
============================
TCGA-COAD BECN1
[1] 285
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.79 0.0116 0.0257
strata=LOW 12 4 4.21 0.0104 0.0257
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1233 0.8840 0.7702 -0.16 0.873
Likelihood ratio test=0.03 on 1 df, p=0.8725
n= 24, number of events= 8
============================
TCGA-COAD FTMT
============================
TCGA-COAD HCAR1
[1] 286
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.34 0.415 1.11
strata=LOW 12 5 3.66 0.492 1.11
Chisq= 1.1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7892 2.2016 0.7693 1.026 0.305
Likelihood ratio test=1.07 on 1 df, p=0.302
n= 24, number of events= 8
============================
TCGA-COAD HILPDA
[1] 287
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 4.45 0.0449 0.0904
strata=LOW 12 6 5.55 0.0360 0.0904
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2031 1.2252 0.6766 0.3 0.764
Likelihood ratio test=0.09 on 1 df, p=0.7634
n= 24, number of events= 10
============================
TCGA-COAD GSTM1
[1] 288
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.43 0.0944 0.222
strata=LOW 12 3 3.57 0.0907 0.222
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4063 0.6661 0.8685 -0.468 0.64
Likelihood ratio test=0.23 on 1 df, p=0.6334
n= 24, number of events= 7
============================
TCGA-COAD MIR222
============================
TCGA-COAD RARRES2
[1] 289
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.71 0.611 1.12
strata=LOW 12 3 4.29 0.386 1.12
Chisq= 1.1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.8880 0.4115 0.8673 -1.024 0.306
Likelihood ratio test=1.12 on 1 df, p=0.2894
n= 24, number of events= 7
============================
TCGA-COAD BRD4
[1] 290
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.42 0.242 0.459
strata=LOW 12 1 1.58 0.216 0.459
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.8082 0.4457 1.2259 -0.659 0.51
Likelihood ratio test=0.46 on 1 df, p=0.4959
n= 24, number of events= 3
============================
TCGA-COAD SOCS1
[1] 291
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.09 0.268 0.76
strata=LOW 12 1 1.91 0.433 0.76
Chisq= 0.8 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9682 0.3798 1.1479 -0.843 0.399
Likelihood ratio test=0.83 on 1 df, p=0.3628
n= 24, number of events= 5
============================
TCGA-COAD MIR17
============================
TCGA-COAD GDF15
[1] 292
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.6 0.748 1.37
strata=LOW 12 3 4.4 0.443 1.37
Chisq= 1.4 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.0037 0.3665 0.8878 -1.131 0.258
Likelihood ratio test=1.38 on 1 df, p=0.2409
n= 24, number of events= 7
============================
TCGA-COAD ARF6
[1] 293
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.91 0.212 0.702
strata=LOW 12 3 2.09 0.396 0.702
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7617 2.1419 0.9294 0.82 0.412
Likelihood ratio test=0.69 on 1 df, p=0.4058
n= 24, number of events= 6
============================
TCGA-COAD CDO1
[1] 294
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.93 0.290 0.767
strata=LOW 12 2 3.07 0.372 0.767
Chisq= 0.8 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7442 0.4751 0.8692 -0.856 0.392
Likelihood ratio test=0.78 on 1 df, p=0.3773
n= 24, number of events= 7
============================
TCGA-COAD CAMKK2
[1] 295
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.61 0.143 0.306
strata=LOW 12 3 2.39 0.156 0.306
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5056 1.6581 0.9235 0.548 0.584
Likelihood ratio test=0.31 on 1 df, p=0.5796
n= 24, number of events= 5
============================
TCGA-COAD LINC01606
[1] 296
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.25 1.36 1.9
strata=LOW 30 7 8.75 0.35 1.9
Chisq= 1.9 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9410 0.3902 0.7083 -1.329 0.184
Likelihood ratio test=1.7 on 1 df, p=0.1917
n= 42, number of events= 11
============================
TCGA-COAD BACH1
[1] 297
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.72 0.797 2.46
strata=LOW 12 4 2.28 1.302 2.46
Chisq= 2.5 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.605 4.979 1.128 1.423 0.155
Likelihood ratio test=2.57 on 1 df, p=0.1088
n= 24, number of events= 6
============================
TCGA-COAD DPP4
[1] 298
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 5.05 0.000465 0.00107
strata=LOW 12 5 4.95 0.000474 0.00107
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.02212 1.02237 0.67619 0.033 0.974
Likelihood ratio test=0 on 1 df, p=0.9739
n= 24, number of events= 10
============================
TCGA-COAD PPP1R13L
[1] 299
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 6 4.73 0.339 0.952
strata=LOW 12 2 3.27 0.491 0.952
Chisq= 1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.8049 0.4471 0.8460 -0.951 0.341
Likelihood ratio test=0.99 on 1 df, p=0.3203
n= 24, number of events= 8
============================
TCGA-COAD MIR150
============================
TCGA-COAD FLT3
[1] 300
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.77 0.550 1.02
strata=LOW 12 4 5.23 0.291 1.02
Chisq= 1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.8525 0.4263 0.8675 -0.983 0.326
Likelihood ratio test=1.03 on 1 df, p=0.3096
n= 24, number of events= 8
============================
TCGA-COAD MAP1LC3A
[1] 301
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.11 1.149 2.39
strata=LOW 12 2 3.89 0.919 2.39
Chisq= 2.4 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.5408 0.2142 1.0965 -1.405 0.16
Likelihood ratio test=2.64 on 1 df, p=0.1045
n= 24, number of events= 7
============================
TCGA-COAD A2M-AS1
[1] 302
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.19 0.0119 0.0256
strata=LOW 12 3 2.81 0.0135 0.0256
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1309 1.1399 0.8190 0.16 0.873
Likelihood ratio test=0.03 on 1 df, p=0.873
n= 24, number of events= 6
============================
TCGA-COAD PDSS2
[1] 303
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.6 0.1396 0.232
strata=LOW 12 6 5.4 0.0673 0.232
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.4069 1.5021 0.8510 0.478 0.633
Likelihood ratio test=0.24 on 1 df, p=0.6242
n= 24, number of events= 8
============================
TCGA-COAD DNAJB6
[1] 304
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.68 0.126 0.331
strata=LOW 12 4 3.32 0.140 0.331
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.4701 1.6001 0.8238 0.571 0.568
Likelihood ratio test=0.32 on 1 df, p=0.57
n= 24, number of events= 7
============================
TCGA-COAD SUV39H1
[1] 305
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.64 0.157 0.561
strata=LOW 12 2 1.36 0.306 0.561
Chisq= 0.6 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.8901 2.4353 1.2276 0.725 0.468
Likelihood ratio test=0.56 on 1 df, p=0.4531
n= 24, number of events= 4
============================
TCGA-COAD LPCAT3
[1] 306
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.69 0.0562 0.136
strata=LOW 12 2 2.31 0.0412 0.136
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4616 0.6303 1.2588 -0.367 0.714
Likelihood ratio test=0.14 on 1 df, p=0.7083
n= 24, number of events= 4
============================
TCGA-COAD MIR761
============================
TCGA-COAD CDCA3
[1] 307
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.8 0.0221 0.0828
strata=LOW 12 1 1.2 0.0331 0.0828
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4043 0.6674 1.4146 -0.286 0.775
Likelihood ratio test=0.08 on 1 df, p=0.7758
n= 24, number of events= 3
============================
TCGA-COAD EPAS1
[1] 308
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.11 1.684 2.68
strata=LOW 12 2 3.89 0.916 2.68
Chisq= 2.7 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.3501 0.2592 0.8818 -1.531 0.126
Likelihood ratio test=2.53 on 1 df, p=0.1114
n= 24, number of events= 6
============================
TCGA-COAD SLC11A2
[1] 309
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.19 0.646 1.43
strata=LOW 12 3 1.81 0.780 1.43
Chisq= 1.4 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.295 3.651 1.157 1.119 0.263
Likelihood ratio test=1.47 on 1 df, p=0.2254
n= 24, number of events= 4
============================
TCGA-COAD CREB3
[1] 310
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 0.967 1.105 2.14
strata=LOW 12 2 3.033 0.352 2.14
Chisq= 2.1 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.127e+01 5.763e-10 2.846e+04 -0.001 0.999
Likelihood ratio test=2.91 on 1 df, p=0.088
n= 24, number of events= 4
============================
TCGA-COAD ATF3
[1] 311
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.27 0.163 0.363
strata=LOW 12 3 3.73 0.143 0.363
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.5192 0.5950 0.8713 -0.596 0.551
Likelihood ratio test=0.37 on 1 df, p=0.5419
n= 24, number of events= 7
============================
TCGA-COAD TGFB1
[1] 312
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.91 0.615 1.02
strata=LOW 12 2 3.09 0.382 1.02
Chisq= 1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9040 0.4050 0.9244 -0.978 0.328
Likelihood ratio test=0.98 on 1 df, p=0.3214
n= 24, number of events= 5
============================
TCGA-COAD SMG9
[1] 313
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 4.16 0.00601 0.0253
strata=LOW 12 2 1.84 0.01356 0.0253
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1597 1.1732 1.0041 0.159 0.874
Likelihood ratio test=0.03 on 1 df, p=0.8737
n= 24, number of events= 6
============================
TCGA-COAD NOX4
[1] 314
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 4.06 0.218 0.528
strata=LOW 12 2 2.94 0.301 0.528
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6029 0.5472 0.8419 -0.716 0.474
Likelihood ratio test=0.55 on 1 df, p=0.4578
n= 24, number of events= 7
============================
TCGA-COAD MIR27A
============================
TCGA-COAD FOXP1
[1] 315
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.15 0.0101 0.0219
strata=LOW 12 2 1.85 0.0117 0.0219
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1481 1.1596 1.0012 0.148 0.882
Likelihood ratio test=0.02 on 1 df, p=0.8825
n= 24, number of events= 4
============================
TCGA-COAD SNCA
[1] 316
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 1.75 2.91 5.42
strata=LOW 12 0 2.25 2.25 5.42
Chisq= 5.4 on 1 degrees of freedom, p= 0.02
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.166e+01 3.921e-10 2.057e+04 -0.001 0.999
Likelihood ratio test=6.95 on 1 df, p=0.008381
n= 24, number of events= 4
============================
TCGA-COAD ENPP2
[1] 317
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.9 0.415 0.83
strata=LOW 12 4 5.1 0.236 0.83
Chisq= 0.8 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7803 0.4583 0.8769 -0.89 0.374
Likelihood ratio test=0.84 on 1 df, p=0.3592
n= 24, number of events= 8
============================
TCGA-COAD BRD2
[1] 318
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.85 0.0119 0.0254
strata=LOW 12 2 2.15 0.0103 0.0254
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1697 0.8439 1.0660 -0.159 0.873
Likelihood ratio test=0.03 on 1 df, p=0.8737
n= 24, number of events= 4
============================
TCGA-COAD ISCU
[1] 319
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.89 0.00456 0.0112
strata=LOW 12 2 2.11 0.00622 0.0112
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.09869 0.90602 0.93161 -0.106 0.916
Likelihood ratio test=0.01 on 1 df, p=0.9154
n= 24, number of events= 5
============================
TCGA-COAD PHF21A
[1] 320
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 2.82 1.7 3.28
strata=LOW 12 1 3.18 1.5 3.28
Chisq= 3.3 on 1 degrees of freedom, p= 0.07
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.7715 0.1701 1.1038 -1.605 0.109
Likelihood ratio test=3.51 on 1 df, p=0.06096
n= 24, number of events= 6
============================
TCGA-COAD PARP6
[1] 321
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.03 0.915 1.89
strata=LOW 12 1 1.97 0.478 1.89
Chisq= 1.9 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.115e+01 6.542e-10 2.845e+04 -0.001 0.999
Likelihood ratio test=2.66 on 1 df, p=0.103
n= 24, number of events= 3
============================
TCGA-COAD ZEB1
[1] 322
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.34 0.0353 0.0799
strata=LOW 12 4 3.66 0.0323 0.0799
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2306 1.2594 0.8175 0.282 0.778
Likelihood ratio test=0.08 on 1 df, p=0.7781
n= 24, number of events= 7
============================
TCGA-COAD LIG3
[1] 323
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.12 0.00660 0.0141
strata=LOW 12 3 2.88 0.00485 0.0141
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1186 1.1259 1.0010 0.118 0.906
Likelihood ratio test=0.01 on 1 df, p=0.9057
n= 24, number of events= 5
============================
TCGA-COAD PEDS1
[1] 324
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.03 0.464 0.956
strata=LOW 12 2 2.97 0.317 0.956
Chisq= 1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.0830 0.3386 1.1608 -0.933 0.351
Likelihood ratio test=1 on 1 df, p=0.3169
n= 24, number of events= 5
============================
TCGA-COAD RPPH1
============================
TCGA-COAD GFRA1
[1] 325
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.31 0.517 1.2
strata=LOW 12 5 3.69 0.463 1.2
Chisq= 1.2 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.9314 2.5381 0.8783 1.06 0.289
Likelihood ratio test=1.2 on 1 df, p=0.2735
n= 24, number of events= 7
============================
TCGA-COAD AQP8
[1] 326
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.78 0.344 0.639
strata=LOW 12 4 3.22 0.191 0.639
Chisq= 0.6 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.9032 2.4676 1.1665 0.774 0.439
Likelihood ratio test=0.68 on 1 df, p=0.4109
n= 24, number of events= 5
============================
TCGA-COAD SIRT1
[1] 327
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.06 0.365 1.17
strata=LOW 12 3 1.94 0.574 1.17
Chisq= 1.2 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.197 3.311 1.170 1.024 0.306
Likelihood ratio test=1.21 on 1 df, p=0.2715
n= 24, number of events= 5
============================
TCGA-COAD MIR15A
============================
TCGA-COAD AKR1C3
[1] 328
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.1 0.00323 0.0067
strata=LOW 12 4 3.9 0.00257 0.0067
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.06687 1.06915 0.81707 0.082 0.935
Likelihood ratio test=0.01 on 1 df, p=0.9348
n= 24, number of events= 7
============================
TCGA-COAD DLD
[1] 329
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.18 0.01428 0.0264
strata=LOW 12 4 3.82 0.00813 0.0264
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1513 1.1634 0.9318 0.162 0.871
Likelihood ratio test=0.03 on 1 df, p=0.8705
n= 24, number of events= 6
============================
TCGA-COAD USP11
[1] 330
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.88 0.667 1.8
strata=LOW 12 1 2.12 0.592 1.8
Chisq= 1.8 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.079e+01 9.376e-10 2.434e+04 -0.001 0.999
Likelihood ratio test=2.81 on 1 df, p=0.09355
n= 24, number of events= 4
============================
TCGA-COAD SREBF2
[1] 331
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.44 0.992 1.58
strata=LOW 12 3 4.56 0.532 1.58
Chisq= 1.6 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9475 0.3877 0.7791 -1.216 0.224
Likelihood ratio test=1.49 on 1 df, p=0.2218
n= 24, number of events= 7
============================
TCGA-COAD MIR190A
============================
TCGA-COAD IFNA8
============================
TCGA-COAD KDM6B
[1] 332
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 1.84 2.52 4.01
strata=LOW 12 1 3.16 1.47 4.01
Chisq= 4 on 1 degrees of freedom, p= 0.05
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.9287 0.1453 1.1190 -1.724 0.0848
Likelihood ratio test=3.91 on 1 df, p=0.04806
n= 24, number of events= 5
============================
TCGA-COAD ACOT1
[1] 333
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.45 0.472 2.38
strata=LOW 12 3 1.55 1.355 2.38
Chisq= 2.4 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.674 5.334 1.189 1.408 0.159
Likelihood ratio test=2.34 on 1 df, p=0.1261
n= 24, number of events= 6
============================
TCGA-COAD RELA
[1] 334
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.55 1.36 2.81
strata=LOW 12 0 1.45 1.45 2.81
Chisq= 2.8 on 1 degrees of freedom, p= 0.09
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.114e+01 6.597e-10 2.323e+04 -0.001 0.999
Likelihood ratio test=3.96 on 1 df, p=0.0465
n= 24, number of events= 3
============================
TCGA-COAD SLC39A7
[1] 335
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.76 0.0318 0.0614
strata=LOW 12 2 2.24 0.0251 0.0614
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2565 0.7737 1.0374 -0.247 0.805
Likelihood ratio test=0.06 on 1 df, p=0.8051
n= 24, number of events= 4
============================
TCGA-COAD POM121L12
============================
TCGA-COAD MIR101-1
============================
TCGA-COAD GABPB1-AS1
[1] 336
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.45 0.0843 0.144
strata=LOW 12 5 4.55 0.0455 0.144
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3295 1.3903 0.8709 0.378 0.705
Likelihood ratio test=0.15 on 1 df, p=0.7006
n= 24, number of events= 7
============================
TCGA-COAD EGFR
[1] 337
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.05 0.536 1.12
strata=LOW 12 3 1.95 0.562 1.12
Chisq= 1.1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.163 3.200 1.161 1.002 0.316
Likelihood ratio test=1.16 on 1 df, p=0.281
n= 24, number of events= 4
============================
TCGA-COAD BRD7
[1] 338
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.39 0.0446 0.0807
strata=LOW 12 5 4.61 0.0328 0.0807
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2111 1.2351 0.7442 0.284 0.777
Likelihood ratio test=0.08 on 1 df, p=0.7751
n= 24, number of events= 8
============================
TCGA-COAD MIR1287
============================
TCGA-COAD MIR23A
============================
TCGA-COAD LCE2C
============================
TCGA-COAD ADAMTS13
[1] 339
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.67 0.668 1.12
strata=LOW 12 3 4.33 0.411 1.12
Chisq= 1.1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.8011 0.4488 0.7754 -1.033 0.302
Likelihood ratio test=1.08 on 1 df, p=0.2993
n= 24, number of events= 7
============================
TCGA-COAD SIRT3
[1] 340
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.44 0.128 0.259
strata=LOW 12 2 2.56 0.122 0.259
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4680 0.6263 0.9276 -0.504 0.614
Likelihood ratio test=0.26 on 1 df, p=0.61
n= 24, number of events= 5
============================
TCGA-COAD CIRBP
[1] 341
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.34 1.180 1.96
strata=LOW 12 2 3.66 0.754 1.96
Chisq= 2 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.1539 0.3154 0.8701 -1.326 0.185
Likelihood ratio test=1.9 on 1 df, p=0.1685
n= 24, number of events= 6
============================
TCGA-COAD BRDT
============================
TCGA-COAD KIF4A
[1] 342
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.17 0.330 1.4
strata=LOW 12 3 1.83 0.754 1.4
Chisq= 1.4 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.280 3.595 1.157 1.106 0.269
Likelihood ratio test=1.43 on 1 df, p=0.2312
n= 24, number of events= 6
============================
TCGA-COAD CPEB1
[1] 343
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.9 0.421 0.819
strata=LOW 12 2 3.1 0.393 0.819
Chisq= 0.8 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7668 0.4645 0.8680 -0.883 0.377
Likelihood ratio test=0.83 on 1 df, p=0.3621
n= 24, number of events= 6
============================
TCGA-COAD LINC01833
[1] 344
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 4.55 0.0665 0.154
strata=LOW 14 5 4.45 0.0681 0.154
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2864 1.3317 0.7321 0.391 0.696
Likelihood ratio test=0.16 on 1 df, p=0.6926
n= 26, number of events= 9
============================
TCGA-COAD MAPKAP1
[1] 345
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 4.11 0.301 0.641
strata=LOW 12 5 3.89 0.319 0.641
Chisq= 0.6 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5850 1.7950 0.7404 0.79 0.429
Likelihood ratio test=0.65 on 1 df, p=0.4219
n= 24, number of events= 8
============================
TCGA-COAD ATF4
[1] 346
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.89 0.319 0.883
strata=LOW 12 2 3.11 0.398 0.883
Chisq= 0.9 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.8109 0.4445 0.8844 -0.917 0.359
Likelihood ratio test=0.89 on 1 df, p=0.3457
n= 24, number of events= 7
============================
TCGA-COAD SLC7A11
[1] 347
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.81 0.0131 0.0254
strata=LOW 12 3 3.19 0.0116 0.0254
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1322 0.8762 0.8293 -0.159 0.873
Likelihood ratio test=0.03 on 1 df, p=0.8734
n= 24, number of events= 6
============================
TCGA-COAD EMC2
[1] 348
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.55 0.195 0.405
strata=LOW 12 2 1.45 0.209 0.405
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7615 2.1415 1.2260 0.621 0.535
Likelihood ratio test=0.41 on 1 df, p=0.5216
n= 24, number of events= 3
============================
TCGA-COAD WWTR1
[1] 349
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.47 0.114 0.225
strata=LOW 12 2 2.53 0.111 0.225
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4305 0.6502 0.9137 -0.471 0.638
Likelihood ratio test=0.23 on 1 df, p=0.634
n= 24, number of events= 5
============================
TCGA-COAD HSPA5
[1] 350
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 1.29 5.67 8.16
strata=LOW 12 2 4.71 1.56 8.16
Chisq= 8.2 on 1 degrees of freedom, p= 0.004
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.65741 0.07013 1.15593 -2.299 0.0215
Likelihood ratio test=6.98 on 1 df, p=0.008225
n= 24, number of events= 6
============================
TCGA-COAD BEX1
[1] 351
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.95 0.566 1.24
strata=LOW 12 2 3.05 0.362 1.24
Chisq= 1.2 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.3181 0.2676 1.2362 -1.066 0.286
Likelihood ratio test=1.31 on 1 df, p=0.2515
n= 24, number of events= 5
============================
TCGA-COAD PML
[1] 352
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.87 0.681 2.59
strata=LOW 12 0 1.13 1.129 2.59
Chisq= 2.6 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.149e+01 4.624e-10 2.885e+04 -0.001 0.999
Likelihood ratio test=3.33 on 1 df, p=0.06815
n= 24, number of events= 3
============================
TCGA-COAD MIR142
============================
TCGA-COAD AEBP2
[1] 353
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.56 0.121 0.413
strata=LOW 12 2 1.44 0.214 0.413
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.768 2.155 1.225 0.627 0.531
Likelihood ratio test=0.42 on 1 df, p=0.5177
n= 24, number of events= 4
============================
TCGA-COAD GPAT4
[1] 354
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.72 0.192 0.455
strata=LOW 12 4 3.28 0.159 0.455
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.6336 1.8844 0.9515 0.666 0.505
Likelihood ratio test=0.45 on 1 df, p=0.5001
n= 24, number of events= 6
============================
TCGA-COAD CA9
[1] 355
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.15 0.0109 0.0242
strata=LOW 12 2 1.85 0.0126 0.0242
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1578 1.1709 1.0152 0.155 0.876
Likelihood ratio test=0.02 on 1 df, p=0.8765
n= 24, number of events= 4
============================
TCGA-COAD STK11
[1] 356
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.85 0.00605 0.0136
strata=LOW 12 4 4.15 0.00560 0.0136
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.08947 0.91442 0.76800 -0.116 0.907
Likelihood ratio test=0.01 on 1 df, p=0.9071
n= 24, number of events= 8
============================
TCGA-COAD TBK1
[1] 357
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.87 0.904 2.89
strata=LOW 12 4 2.13 1.642 2.89
Chisq= 2.9 on 1 degrees of freedom, p= 0.09
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.697 5.459 1.121 1.514 0.13
Likelihood ratio test=2.96 on 1 df, p=0.08549
n= 24, number of events= 6
============================
TCGA-COAD CDKN2A
[1] 358
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.63 0.707 1.5
strata=LOW 12 2 3.37 0.554 1.5
Chisq= 1.5 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.2807 0.2778 1.1188 -1.145 0.252
Likelihood ratio test=1.62 on 1 df, p=0.2029
n= 24, number of events= 6
============================
TCGA-COAD DCAF7
[1] 359
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.64 0.248 0.547
strata=LOW 12 2 1.36 0.298 0.547
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.8774 2.4048 1.2251 0.716 0.474
Likelihood ratio test=0.55 on 1 df, p=0.4587
n= 24, number of events= 3
============================
TCGA-COAD MTF1
[1] 360
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.5 0.0724 0.203
strata=LOW 12 2 2.5 0.1011 0.203
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.4084 0.6647 0.9134 -0.447 0.655
Likelihood ratio test=0.2 on 1 df, p=0.6514
n= 24, number of events= 6
============================
TCGA-COAD MEG8
[1] 361
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.27 0.235 0.451
strata=LOW 12 4 4.73 0.113 0.451
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6205 0.5377 0.9371 -0.662 0.508
Likelihood ratio test=0.45 on 1 df, p=0.5021
n= 24, number of events= 7
============================
TCGA-COAD CLTRN
[1] 362
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.17 0.594 1.43
strata=LOW 12 1 1.83 0.378 1.43
Chisq= 1.4 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.991e+01 2.262e-09 1.760e+04 -0.001 0.999
Likelihood ratio test=2.15 on 1 df, p=0.1422
n= 24, number of events= 3
============================
TCGA-COAD PARP11
[1] 363
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 4.97 0.000230 0.000576
strata=LOW 12 4 4.03 0.000284 0.000576
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.01704 0.98311 0.70961 -0.024 0.981
Likelihood ratio test=0 on 1 df, p=0.9808
n= 24, number of events= 9
============================
TCGA-COAD GABARAPL2
[1] 364
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.83 0.742 1.4
strata=LOW 12 1 2.17 0.628 1.4
Chisq= 1.4 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.2936 0.2743 1.1660 -1.109 0.267
Likelihood ratio test=1.44 on 1 df, p=0.2301
n= 24, number of events= 4
============================
TCGA-COAD CDKN1A
[1] 365
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.22 0.0212 0.0393
strata=LOW 12 3 2.78 0.0169 0.0393
Chisq= 0 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1834 1.2013 0.9259 0.198 0.843
Likelihood ratio test=0.04 on 1 df, p=0.8422
n= 24, number of events= 5
============================
TCGA-COAD NEDD4L
[1] 366
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.97 0.981 1.96
strata=LOW 12 7 5.03 0.776 1.96
Chisq= 2 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.091 2.977 0.818 1.333 0.182
Likelihood ratio test=2.05 on 1 df, p=0.152
n= 24, number of events= 9
============================
TCGA-COAD AR
[1] 367
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.45 0.0890 0.178
strata=LOW 12 3 3.55 0.0863 0.178
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3243 0.7230 0.7710 -0.421 0.674
Likelihood ratio test=0.18 on 1 df, p=0.6723
n= 24, number of events= 7
============================
TCGA-COAD MIR20A
============================
TCGA-COAD HMOX1
[1] 368
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.56 0.0550 0.169
strata=LOW 12 2 2.44 0.0801 0.169
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3849 0.6805 0.9417 -0.409 0.683
Likelihood ratio test=0.17 on 1 df, p=0.6806
n= 24, number of events= 6
============================
TCGA-COAD ZFP36
[1] 369
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.82 0.00826 0.026
strata=LOW 12 2 2.18 0.01449 0.026
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1478 0.8626 0.9178 -0.161 0.872
Likelihood ratio test=0.03 on 1 df, p=0.8715
n= 24, number of events= 6
============================
TCGA-COAD MIR744
============================
TCGA-COAD CTSB
[1] 370
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.98 0.259 0.626
strata=LOW 12 3 4.02 0.257 0.626
Chisq= 0.6 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6061 0.5455 0.7765 -0.78 0.435
Likelihood ratio test=0.62 on 1 df, p=0.4324
n= 24, number of events= 8
============================
TCGA-COAD AGPS
[1] 371
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.22 0.0150 0.0397
strata=LOW 12 3 2.78 0.0174 0.0397
Chisq= 0 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1831 1.2010 0.9199 0.199 0.842
Likelihood ratio test=0.04 on 1 df, p=0.8414
n= 24, number of events= 6
============================
TCGA-COAD MT1DP
[1] 372
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.46 0.0855 0.326
strata=LOW 12 2 1.54 0.1363 0.326
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7468 2.1102 1.3249 0.564 0.573
Likelihood ratio test=0.34 on 1 df, p=0.5626
n= 24, number of events= 4
============================
TCGA-COAD SNX4
[1] 373
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.33 0.0475 0.114
strata=LOW 12 3 2.67 0.0416 0.114
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3364 1.3999 1.0006 0.336 0.737
Likelihood ratio test=0.11 on 1 df, p=0.7373
n= 24, number of events= 5
============================
TCGA-COAD NR4A1
[1] 374
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.75 0.571 1.27
strata=LOW 12 3 4.25 0.369 1.27
Chisq= 1.3 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.1923 0.3035 1.1197 -1.065 0.287
Likelihood ratio test=1.39 on 1 df, p=0.239
n= 24, number of events= 7
============================
TCGA-COAD MFN2
[1] 375
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.44 0.0897 0.413
strata=LOW 12 1 1.56 0.1985 0.413
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.7680 0.4639 1.2251 -0.627 0.531
Likelihood ratio test=0.42 on 1 df, p=0.5177
n= 24, number of events= 5
============================
TCGA-COAD SELENOI
[1] 376
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.51 0.1037 0.212
strata=LOW 12 4 3.49 0.0746 0.212
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.4202 1.5223 0.9197 0.457 0.648
Likelihood ratio test=0.21 on 1 df, p=0.6445
n= 24, number of events= 6
============================
TCGA-COAD AGAP2-AS1
[1] 377
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.15 1.6 2.82
strata=LOW 12 1 2.85 1.2 2.82
Chisq= 2.8 on 1 degrees of freedom, p= 0.09
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.6803 0.1863 1.1205 -1.5 0.134
Likelihood ratio test=2.9 on 1 df, p=0.0887
n= 24, number of events= 5
============================
TCGA-COAD TRIM46
[1] 378
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.84 0.732 1.16
strata=LOW 12 2 3.16 0.426 1.16
Chisq= 1.2 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9504 0.3866 0.9146 -1.039 0.299
Likelihood ratio test=1.11 on 1 df, p=0.2923
n= 24, number of events= 5
============================
TCGA-COAD CYB5R1
[1] 379
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.71 0.0489 0.0856
strata=LOW 12 3 3.29 0.0254 0.0856
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2919 0.7468 1.0011 -0.292 0.771
Likelihood ratio test=0.08 on 1 df, p=0.771
n= 24, number of events= 5
============================
TCGA-COAD PARK7
[1] 380
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.18 0.0142 0.0432
strata=LOW 12 2 1.82 0.0169 0.0432
Chisq= 0 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.254 1.289 1.225 0.207 0.836
Likelihood ratio test=0.04 on 1 df, p=0.8337
n= 24, number of events= 4
============================
TCGA-COAD CARS1
[1] 381
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 6 5.43 0.0595 0.314
strata=LOW 12 1 1.57 0.2061 0.314
Chisq= 0.3 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6252 0.5351 1.1336 -0.552 0.581
Likelihood ratio test=0.34 on 1 df, p=0.5604
n= 24, number of events= 7
============================
TCGA-COAD NOX1
[1] 382
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 2.212 2.21 8.91
strata=LOW 12 3 0.788 6.22 8.91
Chisq= 8.9 on 1 degrees of freedom, p= 0.003
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.316e+01 1.147e+10 3.212e+04 0.001 0.999
Likelihood ratio test=8.6 on 1 df, p=0.003355
n= 24, number of events= 3
============================
TCGA-COAD VDR
[1] 383
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.24 0.0183 0.0482
strata=LOW 12 3 2.76 0.0215 0.0482
Chisq= 0 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2004 1.2219 0.9144 0.219 0.827
Likelihood ratio test=0.05 on 1 df, p=0.8255
n= 24, number of events= 6
============================
TCGA-COAD PROK2
[1] 384
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.38 0.115 0.231
strata=LOW 12 3 3.62 0.107 0.231
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3718 0.6895 0.7778 -0.478 0.633
Likelihood ratio test=0.23 on 1 df, p=0.6308
n= 24, number of events= 7
============================
TCGA-COAD FABP4
[1] 385
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 4.8 0.00868 0.0275
strata=LOW 12 3 3.2 0.01300 0.0275
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1361 0.8728 0.8206 -0.166 0.868
Likelihood ratio test=0.03 on 1 df, p=0.8679
n= 24, number of events= 8
============================
TCGA-COAD ABCB10
[1] 386
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.99 1.32 2.7
strata=LOW 12 5 3.01 1.31 2.7
Chisq= 2.7 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.629 5.098 1.101 1.48 0.139
Likelihood ratio test=2.94 on 1 df, p=0.08652
n= 24, number of events= 6
============================
TCGA-COAD CP
[1] 387
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.55 0.0863 0.214
strata=LOW 12 3 2.45 0.1254 0.214
Chisq= 0.2 on 1 degrees of freedom, p= 0.6
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3780 1.4593 0.8214 0.46 0.645
Likelihood ratio test=0.21 on 1 df, p=0.6464
n= 24, number of events= 6
============================
TCGA-COAD MIR4735
============================
TCGA-COAD MIR130A
============================
TCGA-COAD TUG1
[1] 388
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.77 0.216 0.409
strata=LOW 12 4 3.23 0.186 0.409
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5508 1.7346 0.8718 0.632 0.528
Likelihood ratio test=0.42 on 1 df, p=0.5175
n= 24, number of events= 6
============================
TCGA-COAD MIR9-3HG
[1] 389
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 4.59 0.0755 0.203
strata=LOW 12 4 3.41 0.1016 0.203
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3474 1.4154 0.7743 0.449 0.654
Likelihood ratio test=0.2 on 1 df, p=0.6517
n= 24, number of events= 8
============================
TCGA-COAD MIR196C
============================
TCGA-COAD IFNA21
============================
TCGA-COAD RP11-274B21.9
[1] 390
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.36 0.0383 0.0894
strata=LOW 12 3 2.64 0.0487 0.0894
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2470 1.2802 0.8279 0.298 0.765
Likelihood ratio test=0.09 on 1 df, p=0.7657
n= 24, number of events= 6
============================
TCGA-COAD PVT1
[1] 391
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.2 2.68 4.53
strata=LOW 12 1 2.8 1.15 4.53
Chisq= 4.5 on 1 degrees of freedom, p= 0.03
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.172e+01 3.695e-10 2.419e+04 -0.001 0.999
Likelihood ratio test=5.54 on 1 df, p=0.01861
n= 24, number of events= 4
============================
TCGA-COAD MIR539
============================
TCGA-COAD IFNA2
============================
TCGA-COAD TFRC
[1] 392
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.056 0.542 2.24
strata=LOW 12 2 0.944 1.180 2.24
Chisq= 2.2 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.133e+01 1.830e+09 2.852e+04 0.001 0.999
Likelihood ratio test=3.01 on 1 df, p=0.08285
n= 24, number of events= 3
============================
TCGA-COAD ALOX15B
[1] 393
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.84 0.350 1.18
strata=LOW 12 2 3.16 0.425 1.18
Chisq= 1.2 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.9676 0.3800 0.9229 -1.049 0.294
Likelihood ratio test=1.13 on 1 df, p=0.2883
n= 24, number of events= 7
============================
TCGA-COAD MPC1
[1] 394
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.97 0.000246 0.000611
strata=LOW 12 2 2.03 0.000361 0.000611
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.02263 0.97762 0.91583 -0.025 0.98
Likelihood ratio test=0 on 1 df, p=0.9803
n= 24, number of events= 5
============================
TCGA-COAD MTCH1
[1] 395
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.35 0.0373 0.0732
strata=LOW 12 5 4.65 0.0269 0.0732
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2084 1.2317 0.7717 0.27 0.787
Likelihood ratio test=0.07 on 1 df, p=0.7863
n= 24, number of events= 8
============================
TCGA-COAD MIR324
============================
TCGA-COAD SNHG14
[1] 396
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.67 0.0413 0.0769
strata=LOW 12 5 5.33 0.0207 0.0769
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.2301 0.7945 0.8315 -0.277 0.782
Likelihood ratio test=0.08 on 1 df, p=0.7821
n= 24, number of events= 8
============================
TCGA-COAD PDK4
[1] 397
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.67 0.167 0.366
strata=LOW 12 3 2.33 0.191 0.366
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5528 1.7381 0.9242 0.598 0.55
Likelihood ratio test=0.37 on 1 df, p=0.5449
n= 24, number of events= 5
============================
TCGA-COAD DUOX1
[1] 398
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.83 0.241 0.457
strata=LOW 12 4 3.17 0.214 0.457
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5788 1.7838 0.8676 0.667 0.505
Likelihood ratio test=0.47 on 1 df, p=0.4936
n= 24, number of events= 6
============================
TCGA-COAD LINC00886
[1] 399
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.4 0.575 1.12
strata=LOW 12 6 4.6 0.425 1.12
Chisq= 1.1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.8610 2.3655 0.8379 1.028 0.304
Likelihood ratio test=1.16 on 1 df, p=0.2807
n= 24, number of events= 8
============================
TCGA-COAD NF2
[1] 400
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.58 0.0926 0.19
strata=LOW 12 4 3.42 0.0967 0.19
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3319 1.3937 0.7651 0.434 0.664
Likelihood ratio test=0.19 on 1 df, p=0.6626
n= 24, number of events= 7
============================
TCGA-COAD MIR149
============================
TCGA-COAD CYP4F8
[1] 401
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 4.5 0.0545 0.129
strata=LOW 12 4 3.5 0.0699 0.129
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2580 1.2944 0.7197 0.359 0.72
Likelihood ratio test=0.13 on 1 df, p=0.7204
n= 24, number of events= 8
============================
TCGA-COAD AKR1C1
[1] 402
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.66 0.670 1.44
strata=LOW 12 2 3.34 0.535 1.44
Chisq= 1.4 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.2591 0.2839 1.1194 -1.125 0.261
Likelihood ratio test=1.56 on 1 df, p=0.2116
n= 24, number of events= 6
============================
TCGA-COAD PRKCA
[1] 403
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 4.32 1.24 3.66
strata=LOW 12 5 2.68 2.01 3.66
Chisq= 3.7 on 1 degrees of freedom, p= 0.06
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.836 6.270 1.098 1.672 0.0945
Likelihood ratio test=3.86 on 1 df, p=0.04938
n= 24, number of events= 7
============================
TCGA-COAD CD44
[1] 404
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 1.8 0.0213 0.0571
strata=LOW 12 1 1.2 0.0321 0.0571
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3004 0.7405 1.2613 -0.238 0.812
Likelihood ratio test=0.06 on 1 df, p=0.8094
n= 24, number of events= 3
============================
TCGA-COAD FBXW7
[1] 405
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.59 0.705 1.77
strata=LOW 12 4 2.41 1.051 1.77
Chisq= 1.8 on 1 degrees of freedom, p= 0.2
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.104 3.015 0.870 1.269 0.205
Likelihood ratio test=1.73 on 1 df, p=0.1879
n= 24, number of events= 6
============================
TCGA-COAD YAP1
[1] 406
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 2.92 2.92 7.32
strata=LOW 12 5 2.08 4.12 7.32
Chisq= 7.3 on 1 degrees of freedom, p= 0.007
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.170e+01 2.668e+09 1.877e+04 0.001 0.999
Likelihood ratio test=9.02 on 1 df, p=0.002666
n= 24, number of events= 5
============================
TCGA-COAD MTOR
[1] 407
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.96 0.232 0.613
strata=LOW 12 4 3.04 0.301 0.613
Chisq= 0.6 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.6663 1.9471 0.8669 0.769 0.442
Likelihood ratio test=0.63 on 1 df, p=0.4289
n= 24, number of events= 7
============================
TCGA-COAD RICTOR
[1] 408
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.97 0.314 0.964
strata=LOW 12 3 2.03 0.458 0.964
Chisq= 1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.094 2.987 1.167 0.938 0.348
Likelihood ratio test=1.01 on 1 df, p=0.3153
n= 24, number of events= 5
============================
TCGA-COAD WIPI2
[1] 409
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.17 0.215 0.478
strata=LOW 12 2 2.83 0.241 0.478
Chisq= 0.5 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.6016 0.5479 0.8817 -0.682 0.495
Likelihood ratio test=0.49 on 1 df, p=0.4846
n= 24, number of events= 6
============================
TCGA-COAD IREB2
[1] 410
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 1.74 1.74 4.15
strata=LOW 12 4 2.26 1.34 4.15
Chisq= 4.2 on 1 degrees of freedom, p= 0.04
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.158e+01 2.357e+09 2.378e+04 0.001 0.999
Likelihood ratio test=5.22 on 1 df, p=0.02238
n= 24, number of events= 4
============================
TCGA-COAD GOT1
[1] 411
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 4.08 0.00171 0.00616
strata=LOW 12 3 2.92 0.00239 0.00616
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.0742 1.0770 0.9459 0.078 0.937
Likelihood ratio test=0.01 on 1 df, p=0.9373
n= 24, number of events= 7
============================
TCGA-COAD CD82
[1] 412
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.31 0.859 2.29
strata=LOW 12 1 2.69 1.059 2.29
Chisq= 2.3 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.5390 0.2146 1.1187 -1.376 0.169
Likelihood ratio test=2.41 on 1 df, p=0.1205
n= 24, number of events= 6
============================
TCGA-COAD MAPK9
[1] 413
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 4.77 2.98 10.2
strata=LOW 12 6 2.23 6.35 10.2
Chisq= 10.2 on 1 degrees of freedom, p= 0.001
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.190e+01 3.231e+09 1.761e+04 0.001 0.999
Likelihood ratio test=11.97 on 1 df, p=0.0005413
n= 24, number of events= 7
============================
TCGA-COAD LGMN
[1] 414
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.87 0.00606 0.0175
strata=LOW 12 2 2.13 0.00816 0.0175
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1323 0.8761 1.0010 -0.132 0.895
Likelihood ratio test=0.02 on 1 df, p=0.8949
n= 24, number of events= 5
============================
TCGA-COAD PARP2
[1] 415
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.09 0.382 1.2
strata=LOW 12 3 1.91 0.617 1.2
Chisq= 1.2 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.203 3.331 1.162 1.035 0.301
Likelihood ratio test=1.25 on 1 df, p=0.2643
n= 24, number of events= 5
============================
TCGA-COAD MIR16-1
============================
TCGA-COAD ATG4D
[1] 416
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.76 0.155 0.393
strata=LOW 12 4 3.24 0.181 0.393
Chisq= 0.4 on 1 degrees of freedom, p= 0.5
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.5369 1.7107 0.8669 0.619 0.536
Likelihood ratio test=0.4 on 1 df, p=0.5257
n= 24, number of events= 7
============================
TCGA-COAD RBMS1
[1] 417
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.57 0.0732 0.151
strata=LOW 12 3 3.43 0.0547 0.151
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3544 0.7016 0.9157 -0.387 0.699
Likelihood ratio test=0.15 on 1 df, p=0.6961
n= 24, number of events= 6
============================
TCGA-COAD GSTZ1
[1] 418
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.67 0.0418 0.116
strata=LOW 12 2 2.33 0.0478 0.116
Chisq= 0.1 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.3407 0.7113 1.0055 -0.339 0.735
Likelihood ratio test=0.11 on 1 df, p=0.7353
n= 24, number of events= 5
============================
TCGA-COAD SRSF9
[1] 419
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.83 0.00739 0.019
strata=LOW 12 3 3.17 0.00893 0.019
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1125 0.8936 0.8174 -0.138 0.891
Likelihood ratio test=0.02 on 1 df, p=0.8905
n= 24, number of events= 7
============================
TCGA-COAD HIF1A
[1] 420
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 3.59 0.550 1.24
strata=LOW 12 3 4.41 0.449 1.24
Chisq= 1.2 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.8418 0.4309 0.7755 -1.085 0.278
Likelihood ratio test=1.19 on 1 df, p=0.2748
n= 24, number of events= 8
============================
TCGA-COAD FNDC3B
[1] 421
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.93 0.449 0.881
strata=LOW 12 5 4.07 0.213 0.881
Chisq= 0.9 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.044 2.839 1.161 0.899 0.369
Likelihood ratio test=0.93 on 1 df, p=0.3359
n= 24, number of events= 6
============================
TCGA-COAD RHEBP1
============================
TCGA-COAD PSEN1
[1] 422
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.31 0.0283 0.0634
strata=LOW 12 5 4.69 0.0199 0.0634
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2059 1.2286 0.8189 0.251 0.801
Likelihood ratio test=0.06 on 1 df, p=0.8017
n= 24, number of events= 8
============================
TCGA-COAD ADIPOQ
[1] 423
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 3.65 0.0338 0.0706
strata=LOW 25 5 5.35 0.0231 0.0706
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1953 0.8226 0.7361 -0.265 0.791
Likelihood ratio test=0.07 on 1 df, p=0.7924
n= 37, number of events= 9
============================
TCGA-COAD MUC1
[1] 424
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.28 0.0355 0.0688
strata=LOW 12 3 2.72 0.0299 0.0688
Chisq= 0.1 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.2453 1.2780 0.9372 0.262 0.793
Likelihood ratio test=0.07 on 1 df, p=0.7921
n= 24, number of events= 5
============================
TCGA-COAD CAV1
[1] 425
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.19 1.485 2.36
strata=LOW 12 4 5.81 0.561 2.36
Chisq= 2.4 on 1 degrees of freedom, p= 0.1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.2547 0.2852 0.8698 -1.443 0.149
Likelihood ratio test=2.25 on 1 df, p=0.1337
n= 24, number of events= 8
============================
TCGA-COAD SEC24B
[1] 426
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.01 2.35e-05 4.83e-05
strata=LOW 12 3 2.99 1.58e-05 4.83e-05
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.007025 1.007050 1.011117 0.007 0.994
Likelihood ratio test=0 on 1 df, p=0.9945
n= 24, number of events= 5
============================
TCGA-COAD PRDX6
[1] 427
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.98 0.000125 0.000375
strata=LOW 12 2 2.02 0.000185 0.000375
Chisq= 0 on 1 degrees of freedom, p= 1
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.01943 0.98076 1.00297 -0.019 0.985
Likelihood ratio test=0 on 1 df, p=0.9845
n= 24, number of events= 5
============================
TCGA-COAD TMEM161B-DT
[1] 428
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 1.85 0.387 0.727
strata=LOW 12 4 3.15 0.227 0.727
Chisq= 0.7 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.9526 2.5924 1.1589 0.822 0.411
Likelihood ratio test=0.77 on 1 df, p=0.3807
n= 24, number of events= 5
============================
TCGA-COAD PGD
[1] 429
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 5 4.11 0.192 0.814
strata=LOW 12 1 1.89 0.418 0.814
Chisq= 0.8 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.0097 0.3643 1.1645 -0.867 0.386
Likelihood ratio test=0.86 on 1 df, p=0.3546
n= 24, number of events= 6
============================
TCGA-COAD RHOT1
[1] 430
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 2.53 0.1117 0.199
strata=LOW 12 4 3.47 0.0815 0.199
Chisq= 0.2 on 1 degrees of freedom, p= 0.7
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.3886 1.4749 0.8765 0.443 0.658
Likelihood ratio test=0.2 on 1 df, p=0.6518
n= 24, number of events= 6
============================
TCGA-COAD ACSL1
[1] 431
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 2.78 0.0173 0.0394
strata=LOW 12 2 2.22 0.0217 0.0394
Chisq= 0 on 1 degrees of freedom, p= 0.8
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -0.1820 0.8336 0.9176 -0.198 0.843
Likelihood ratio test=0.04 on 1 df, p=0.842
n= 24, number of events= 5
============================
TCGA-COAD NEDD4
[1] 432
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.23 0.469 1.04
strata=LOW 12 5 3.77 0.402 1.04
Chisq= 1 on 1 degrees of freedom, p= 0.3
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.8645 2.3739 0.8732 0.99 0.322
Likelihood ratio test=1.05 on 1 df, p=0.3065
n= 24, number of events= 7
============================
TCGA-COAD ELOVL5
[1] 433
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.06 0.368 0.767
strata=LOW 12 4 2.94 0.383 0.767
Chisq= 0.8 on 1 degrees of freedom, p= 0.4
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.7503 2.1177 0.8757 0.857 0.392
Likelihood ratio test=0.78 on 1 df, p=0.377
n= 24, number of events= 6
============================
TCGA-COAD YY1AP1
[1] 434
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 3.23 0.0159 0.0346
strata=LOW 12 3 2.77 0.0184 0.0346
Chisq= 0 on 1 degrees of freedom, p= 0.9
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 0.1522 1.1644 0.8195 0.186 0.853
Likelihood ratio test=0.03 on 1 df, p=0.8527
n= 24, number of events= 6
============================
Display the results only for genes where a significant difference in survival has been reported.
significant_genes
[1] "TIMP1" "MMD" "PCAT1" "HELLS" "ATG5" "PRR5" "MYB" "GSK3B" "ALOX12" "KDM5A" "SNCA" "KDM6B" "HSPA5" "NOX1" "PVT1" "YAP1" "IREB2" "MAPK9"
num_significant_genes <- length(significant_genes)
if (num_significant_genes > 0) {
for (i in 1 : num_significant_genes) {
project <- significant_projects[[i]]
gene <- significant_genes[[i]]
cat(project, gene, "\n\n")
gene_df <- construct_gene_df(gene, project)
fit <- compute_surival_fit(gene_df)
survival <- compute_survival_diff(gene_df)
cox <- compute_cox(gene_df)
print(survival)
cat("\n")
print(cox)
print(plot_survival(fit))
cat("\n\n============================\n\n")
}
}
TCGA-COAD TIMP1
Warning: Loglik converged before variable 1 ; coefficient may be infinite.
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 6 2.38 5.51 9.2
strata=LOW 12 0 3.62 3.62 9.2
Chisq= 9.2 on 1 degrees of freedom, p= 0.002
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.173e+01 3.653e-10 1.714e+04 -0.001 0.999
Likelihood ratio test=11.17 on 1 df, p=0.0008311
n= 24, number of events= 6
============================
TCGA-COAD MMD
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 5.62 1.22 4.44
strata=LOW 12 5 2.38 2.89 4.44
Chisq= 4.4 on 1 degrees of freedom, p= 0.04
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.6070 4.9877 0.8434 1.905 0.0567
Likelihood ratio test=4.15 on 1 df, p=0.04173
n= 24, number of events= 8
============================
TCGA-COAD PCAT1
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 3.17 1.49 4.11
strata=LOW 12 5 2.83 1.67 4.11
Chisq= 4.1 on 1 degrees of freedom, p= 0.04
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 1.956 7.074 1.122 1.744 0.0812
Likelihood ratio test=4 on 1 df, p=0.04557
n= 24, number of events= 6
============================
TCGA-COAD HELLS
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 3.73 0.802 4.09
strata=LOW 12 3 1.27 2.352 4.09
Chisq= 4.1 on 1 degrees of freedom, p= 0.04
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.156e+01 2.305e+09 2.372e+04 0.001 0.999
Likelihood ratio test=5.16 on 1 df, p=0.02312
n= 24, number of events= 5
============================
TCGA-COAD ATG5
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 1.77 1.77 4.32
strata=LOW 12 4 2.23 1.40 4.32
Chisq= 4.3 on 1 degrees of freedom, p= 0.04
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.164e+01 2.491e+09 2.394e+04 0.001 0.999
Likelihood ratio test=5.36 on 1 df, p=0.02063
n= 24, number of events= 4
============================
TCGA-COAD PRR5
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 2.2 1.48 4.53
strata=LOW 12 0 1.8 1.80 4.53
Chisq= 4.5 on 1 degrees of freedom, p= 0.03
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.170e+01 3.768e-10 2.416e+04 -0.001 0.999
Likelihood ratio test=5.52 on 1 df, p=0.01875
n= 24, number of events= 4
============================
TCGA-COAD MYB
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 2 4.38 1.29 5.38
strata=LOW 12 4 1.62 3.48 5.38
Chisq= 5.4 on 1 degrees of freedom, p= 0.02
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.224 9.244 1.139 1.952 0.0509
Likelihood ratio test=5.02 on 1 df, p=0.02501
n= 24, number of events= 6
============================
TCGA-COAD GSK3B
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 2.59 2.59 7.45
strata=LOW 12 4 1.41 4.79 7.45
Chisq= 7.5 on 1 degrees of freedom, p= 0.006
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.204e+01 3.738e+09 2.218e+04 0.001 0.999
Likelihood ratio test=8.44 on 1 df, p=0.003673
n= 24, number of events= 4
============================
TCGA-COAD ALOX12
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 6 3.03 2.91 6.02
strata=LOW 12 0 2.97 2.97 6.02
Chisq= 6 on 1 degrees of freedom, p= 0.01
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.124e+01 5.971e-10 1.655e+04 -0.001 0.999
Likelihood ratio test=8.32 on 1 df, p=0.003917
n= 24, number of events= 6
============================
TCGA-COAD KDM5A
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 2.95 1.29 5.56
strata=LOW 12 3 1.05 3.59 5.56
Chisq= 5.6 on 1 degrees of freedom, p= 0.02
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.202e+01 3.667e+09 2.558e+04 0.001 0.999
Likelihood ratio test=6.3 on 1 df, p=0.01209
n= 24, number of events= 4
============================
TCGA-COAD SNCA
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 1.75 2.91 5.42
strata=LOW 12 0 2.25 2.25 5.42
Chisq= 5.4 on 1 degrees of freedom, p= 0.02
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.166e+01 3.921e-10 2.057e+04 -0.001 0.999
Likelihood ratio test=6.95 on 1 df, p=0.008381
n= 24, number of events= 4
============================
TCGA-COAD KDM6B
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 1.84 2.52 4.01
strata=LOW 12 1 3.16 1.47 4.01
Chisq= 4 on 1 degrees of freedom, p= 0.05
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -1.9287 0.1453 1.1190 -1.724 0.0848
Likelihood ratio test=3.91 on 1 df, p=0.04806
n= 24, number of events= 5
============================
TCGA-COAD HSPA5
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 4 1.29 5.67 8.16
strata=LOW 12 2 4.71 1.56 8.16
Chisq= 8.2 on 1 degrees of freedom, p= 0.004
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.65741 0.07013 1.15593 -2.299 0.0215
Likelihood ratio test=6.98 on 1 df, p=0.008225
n= 24, number of events= 6
============================
TCGA-COAD NOX1
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 2.212 2.21 8.91
strata=LOW 12 3 0.788 6.22 8.91
Chisq= 8.9 on 1 degrees of freedom, p= 0.003
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.316e+01 1.147e+10 3.212e+04 0.001 0.999
Likelihood ratio test=8.6 on 1 df, p=0.003355
n= 24, number of events= 3
============================
TCGA-COAD PVT1
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 3 1.2 2.68 4.53
strata=LOW 12 1 2.8 1.15 4.53
Chisq= 4.5 on 1 degrees of freedom, p= 0.03
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW -2.172e+01 3.695e-10 2.419e+04 -0.001 0.999
Likelihood ratio test=5.54 on 1 df, p=0.01861
n= 24, number of events= 4
============================
TCGA-COAD YAP1
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 2.92 2.92 7.32
strata=LOW 12 5 2.08 4.12 7.32
Chisq= 7.3 on 1 degrees of freedom, p= 0.007
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.170e+01 2.668e+09 1.877e+04 0.001 0.999
Likelihood ratio test=9.02 on 1 df, p=0.002666
n= 24, number of events= 5
============================
TCGA-COAD IREB2
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 0 1.74 1.74 4.15
strata=LOW 12 4 2.26 1.34 4.15
Chisq= 4.2 on 1 degrees of freedom, p= 0.04
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.158e+01 2.357e+09 2.378e+04 0.001 0.999
Likelihood ratio test=5.22 on 1 df, p=0.02238
n= 24, number of events= 4
============================
TCGA-COAD MAPK9
Call:
survdiff(formula = Surv(overall_survival, deceased) ~ strata,
data = gene_df)
N Observed Expected (O-E)^2/E (O-E)^2/V
strata=HIGH 12 1 4.77 2.98 10.2
strata=LOW 12 6 2.23 6.35 10.2
Chisq= 10.2 on 1 degrees of freedom, p= 0.001
Call:
coxph(formula = Surv(overall_survival, deceased) ~ strata, data = gene_df)
coef exp(coef) se(coef) z p
strataLOW 2.190e+01 3.231e+09 1.761e+04 0.001 0.999
Likelihood ratio test=11.97 on 1 df, p=0.0005413
n= 24, number of events= 7
============================
De La Salle University, Manila, Philippines, gonzales.markedward@gmail.com↩︎
De La Salle University, Manila, Philippines, anish.shrestha@dlsu.edu.ph↩︎